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

A

abs(DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A[i] = Math.abs(A[i]).
abs(DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A[row,col] = Math.abs(A[row,col]).
abs - Static variable in class cern.jet.math.Functions
Function that returns Math.abs(a).
abs - Static variable in class cern.jet.math.IntFunctions
Function that returns Math.abs(a) == (a < 0) ? -a : a.
abs(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
abs(double, double) - Static method in class cern.jet.math.tdcomplex.DComplex
 
abs - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
Unary functions
abs - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.abs(a).
abs(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
abs(float, float) - Static method in class cern.jet.math.tfcomplex.FComplex
 
abs - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
Unary functions
abs - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.abs(a).
abs - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns Math.abs(a) == (a < 0) ? -a : a.
abs - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns Math.abs(a) == (a < 0) ? -a : a.
abs(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
abs() - Method in class flanagan.analysis.ErrorProp
 
abs() - Method in class flanagan.analysis.Stat
 
abs() - Method in class flanagan.math.ArrayMaths
 
abs() - Method in class hephysics.particle.LParticle
Magnitude
abs() - Method in class hephysics.vec.Hep3Vector
Magnitude
abs(double[]) - Static method in class jhplot.math.ArrayMathUtils
Takes the absolute value of each component of an array.
abs(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Takes the absolute value of each component of an array.
abs(int[]) - Static method in class jhplot.math.ArrayMathUtils
Takes the absolute value of each component of an array.
abs(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Takes the absolute value of each component of an array.
ABS - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.abs method wrapped as a ComposableFunction.
abs() - Method in class org.apache.commons.math.complex.Complex
Return the absolute value of this complex number.
abs() - Method in class org.apache.commons.math.fraction.BigFraction
Returns the absolute value of this BigFraction.
abs() - Method in class org.apache.commons.math.fraction.Fraction
Returns the absolute value of this fraction.
abs(int) - Static method in class org.apache.commons.math.util.FastMath
Absolute value.
abs(long) - Static method in class org.apache.commons.math.util.FastMath
Absolute value.
abs(float) - Static method in class org.apache.commons.math.util.FastMath
Absolute value.
abs(double) - Static method in class org.apache.commons.math.util.FastMath
Absolute value.
AbstractBaseHistogram - Class in hep.aida.ref.histogram
 
AbstractBaseHistogram(String, String, int) - Constructor for class hep.aida.ref.histogram.AbstractBaseHistogram
Creates a new instance of BaseHistogram.
AbstractBaseHistogram() - Constructor for class hep.aida.ref.histogram.AbstractBaseHistogram
 
AbstractBaseHistogram(String, String, int, String) - Constructor for class hep.aida.ref.histogram.AbstractBaseHistogram
 
AbstractBin - Class in cern.hep.aida.bin
Abstract base class for all arbitrary-dimensional bins consumes double elements.
AbstractBin1D - Class in cern.hep.aida.bin
Abstract base class for all 1-dimensional bins consumes double elements.
AbstractBinner1D - Class in hep.aida.ref.histogram.binner
 
AbstractBinner1D(int) - Constructor for class hep.aida.ref.histogram.binner.AbstractBinner1D
Creates a new instance of OneDBinner.
AbstractBinner1D(Binner1D) - Constructor for class hep.aida.ref.histogram.binner.AbstractBinner1D
 
AbstractBooleanList - Class in cern.colt.list
Abstract base class for resizable lists holding boolean elements; abstract.
AbstractBooleanList - Class in cern.colt.list.tboolean
Abstract base class for resizable lists holding boolean elements; abstract.
AbstractByteList - Class in cern.colt.list
Abstract base class for resizable lists holding byte elements; abstract.
AbstractByteList - Class in cern.colt.list.tbyte
Abstract base class for resizable lists holding byte elements; abstract.
AbstractCharList - Class in cern.colt.list
Abstract base class for resizable lists holding char elements; abstract.
AbstractCharList - Class in cern.colt.list.tchar
Abstract base class for resizable lists holding char elements; abstract.
AbstractChrono - Class in umontreal.iro.lecuyer.util
AbstractChrono is a class that acts as an interface to the system clock and calculates the CPU or system time consumed by parts of a program.
AbstractChrono() - Constructor for class umontreal.iro.lecuyer.util.AbstractChrono
 
AbstractCollection - Class in cern.colt.list
Abstract base class for resizable collections holding objects or primitive data types such as int, float, etc.
AbstractContinousDistribution - Class in cern.jet.random
Abstract base class for all continous distributions.
AbstractContinousDoubleDistribution - Class in cern.jet.random.tdouble
Abstract base class for all continous distributions.
AbstractContinousFloatDistribution - Class in cern.jet.random.tfloat
Abstract base class for all continous distributions.
AbstractContinuousDistribution - Class in org.apache.commons.math.distribution
Base class for continuous distributions.
AbstractContinuousRandomVariable - Class in jhplot.math.num.random
Base continuous random variable that provides a {@link RNG) instance as a source for uniform random numbers.
AbstractDevModelFunction - Class in hep.aida.ref.function
 
AbstractDevModelFunction() - Constructor for class hep.aida.ref.function.AbstractDevModelFunction
 
AbstractDiscreteDistribution - Class in cern.jet.random
Abstract base class for all discrete distributions.
AbstractDiscreteDistribution - Class in cern.jet.random.tdouble
Abstract base class for all discrete distributions.
AbstractDiscreteRandomVariable - Class in jhplot.math.num.random
Base continuous random variable that provides a {@link RNG) instance as a source for uniform random numbers.
AbstractDistribution - Class in cern.jet.random
Abstract base class for all random distributions.
AbstractDistribution - Class in org.apache.commons.math.distribution
Base class for probability distributions.
AbstractDoubleBin - Class in hep.aida.tdouble.bin
Abstract base class for all arbitrary-dimensional bins consumes double elements.
AbstractDoubleBin1D - Class in hep.aida.tdouble.bin
Abstract base class for all 1-dimensional bins consumes double elements.
AbstractDoubleDistribution - Class in cern.jet.random.tdouble
Abstract base class for all random distributions.
AbstractDoubleIntMap - Class in cern.colt.map
Abstract base class for hash maps holding (key,value) associations of type (double-->int).
AbstractDoubleIntMap - Class in cern.colt.map.tdouble
Abstract base class for hash maps holding (key,value) associations of type (double-->int).
AbstractDoubleIterationMonitor - Class in cern.colt.matrix.tdouble.algo.solver
Partial implementation of an iteration reporter
AbstractDoubleIterationMonitor() - Constructor for class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
Constructor for AbstractIterationMonitor.
AbstractDoubleIterativeSolver - Class in cern.colt.matrix.tdouble.algo.solver
Partial implementation of an iterative solver
AbstractDoubleIterativeSolver() - Constructor for class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterativeSolver
Constructor for AbstractIterativeSolver.
AbstractDoubleList - Class in cern.colt.list
Abstract base class for resizable lists holding double elements; abstract.
AbstractDoubleList - Class in cern.colt.list.tdouble
Abstract base class for resizable lists holding double elements; abstract.
AbstractDoubleLongMap - Class in cern.colt.map.tdouble
Abstract base class for hash maps holding (key,value) associations of type (double-->long).
AbstractEstimator - Class in org.apache.commons.math.estimation
Deprecated. as of 2.0, everything in package org.apache.commons.math.estimation has been deprecated and replaced by package org.apache.commons.math.optimization.general
AbstractFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math.linear
Basic implementation of FieldMatrix methods regardless of the underlying storage.
AbstractFitMethod - Class in hep.aida.ref.fitter.fitmethod
 
AbstractFitMethod(int, String[]) - Constructor for class hep.aida.ref.fitter.fitmethod.AbstractFitMethod
 
AbstractFloatBin - Class in hep.aida.tfloat.bin
Abstract base class for all arbitrary-dimensional bins consumes float elements.
AbstractFloatBin1D - Class in hep.aida.tfloat.bin
Abstract base class for all 1-dimensional bins consumes float elements.
AbstractFloatDistribution - Class in cern.jet.random.tfloat
Abstract base class for all random distributions.
AbstractFloatIntMap - Class in cern.colt.map.tfloat
Abstract base class for hash maps holding (key,value) associations of type (float-->int).
AbstractFloatIterationMonitor - Class in cern.colt.matrix.tfloat.algo.solver
Partial implementation of an iteration reporter
AbstractFloatIterationMonitor() - Constructor for class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
Constructor for AbstractIterationMonitor.
AbstractFloatIterativeSolver - Class in cern.colt.matrix.tfloat.algo.solver
Partial implementation of an iterative solver
AbstractFloatIterativeSolver() - Constructor for class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterativeSolver
Constructor for AbstractIterativeSolver.
AbstractFloatList - Class in cern.colt.list
Abstract base class for resizable lists holding float elements; abstract.
AbstractFloatList - Class in cern.colt.list.tfloat
Abstract base class for resizable lists holding float elements; abstract.
AbstractFloatLongMap - Class in cern.colt.map.tfloat
Abstract base class for hash maps holding (key,value) associations of type (float-->long).
AbstractFormat - Class in org.apache.commons.math.fraction
Common part shared by both FractionFormat and BigFractionFormat.
AbstractFormatter - Class in cern.colt.matrix
Abstract base class for flexible, well human readable matrix print formatting.
AbstractFormatter - Class in cern.colt.matrix.impl
Abstract base class for flexible, well human readable matrix print formatting.
AbstractIFunction - Class in hep.aida.ref.function
AbstractIFunction is implementation of the IFunction.
AbstractIFunction() - Constructor for class hep.aida.ref.function.AbstractIFunction
No-argument constructor to be used for cloning.
AbstractIFunction(String, int, int) - Constructor for class hep.aida.ref.function.AbstractIFunction
Creates a new instance of AbstractIFunction with default variable names (x0, x1, ...) and default parameter names (p0, p1, ...)
AbstractIFunction(String[], String[]) - Constructor for class hep.aida.ref.function.AbstractIFunction
Creates a new instance of AbstractIFunction with specified variable and parameter names.
AbstractIFunction(String, String[], String[]) - Constructor for class hep.aida.ref.function.AbstractIFunction
 
AbstractIntDoubleMap - Class in cern.colt.map
Abstract base class for hash maps holding (key,value) associations of type (int-->double).
AbstractIntDoubleMap - Class in cern.colt.map.tdouble
Abstract base class for hash maps holding (key,value) associations of type (int-->double).
AbstractIntegerDistribution - Class in org.apache.commons.math.distribution
Base class for integer-valued discrete distributions.
AbstractIntegrator - Class in org.apache.commons.math.ode
Base class managing common boilerplate for all integrators.
AbstractIntegrator(String) - Constructor for class org.apache.commons.math.ode.AbstractIntegrator
Build an instance.
AbstractIntFloatMap - Class in cern.colt.map.tfloat
Abstract base class for hash maps holding (key,value) associations of type (int-->float).
AbstractIntIntMap - Class in cern.colt.map
Abstract base class for hash maps holding (key,value) associations of type (int-->int).
AbstractIntIntMap - Class in cern.colt.map.tint
Abstract base class for hash maps holding (key,value) associations of type (int-->int).
AbstractIntList - Class in cern.colt.list
Abstract base class for resizable lists holding int elements; abstract.
AbstractIntList - Class in cern.colt.list.tint
Abstract base class for resizable lists holding int elements; abstract.
AbstractIntLongMap - Class in cern.colt.map.tlong
Abstract base class for hash maps holding (key,value) associations of type (int-->long).
AbstractIntObjectMap - Class in cern.colt.map
Abstract base class for hash maps holding (key,value) associations of type (int-->Object).
AbstractIntObjectMap - Class in cern.colt.map.tobject
Abstract base class for hash maps holding (key,value) associations of type (int-->Object).
AbstractLeastSquaresOptimizer - Class in org.apache.commons.math.optimization.general
Base class for implementing least squares optimizers.
AbstractLinearOptimizer - Class in org.apache.commons.math.optimization.linear
Base class for implementing linear optimizers.
AbstractList - Class in cern.colt.list
Abstract base class for resizable lists holding objects or primitive data types such as int, float, etc.
AbstractListChromosome<T> - Class in org.apache.commons.math.genetics
Chromosome represented by an immutable list of a fixed length.
AbstractListChromosome(List<T>) - Constructor for class org.apache.commons.math.genetics.AbstractListChromosome
Constructor.
AbstractListChromosome(T[]) - Constructor for class org.apache.commons.math.genetics.AbstractListChromosome
Constructor.
AbstractLongDoubleMap - Class in cern.colt.map.tdouble
Abstract base class for hash maps holding (key,value) associations of type (int-->double).
AbstractLongFloatMap - Class in cern.colt.map.tfloat
Abstract base class for hash maps holding (key,value) associations of type (int-->float).
AbstractLongIntMap - Class in cern.colt.map.tlong
Abstract base class for hash maps holding (key,value) associations of type (long-->int).
AbstractLongList - Class in cern.colt.list
Abstract base class for resizable lists holding long elements; abstract.
AbstractLongList - Class in cern.colt.list.tlong
Abstract base class for resizable lists holding long elements; abstract.
AbstractLongLongMap - Class in cern.colt.map.tlong
Abstract base class for hash maps holding (key,value) associations of type (long-->long).
AbstractLongObjectMap - Class in cern.colt.map
Abstract base class for hash maps holding (key,value) associations of type (long-->Object).
AbstractLongObjectMap - Class in cern.colt.map.tobject
Abstract base class for hash maps holding (key,value) associations of type (long-->Object).
AbstractMap - Class in cern.colt.map
Abstract base class for hash maps holding objects or primitive data types such as int, float, etc.
AbstractMatrix - Class in cern.colt.matrix
Abstract base class for arbitrary-dimensional matrices holding objects or primitive data types such as int, float, etc.
AbstractMatrix - Class in cern.colt.matrix.impl
Abstract base class for arbitrary-dimensional matrices holding objects or primitive data types such as int, float, etc.
AbstractMatrix1D - Class in cern.colt.matrix
Abstract base class for 1-d matrices (aka vectors) holding objects or primitive data types such as int, double, etc.
AbstractMatrix1D - Class in cern.colt.matrix.impl
Abstract base class for 1-d matrices (aka vectors) holding objects or primitive data types such as int, double, etc.
AbstractMatrix2D - Class in cern.colt.matrix
Abstract base class for 2-d matrices holding objects or primitive data types such as int, double, etc.
AbstractMatrix2D - Class in cern.colt.matrix.impl
Abstract base class for 2-d matrices holding objects or primitive data types such as int, double, etc.
AbstractMatrix3D - Class in cern.colt.matrix
Abstract base class for 3-d matrices holding objects or primitive data types such as int, double, etc.
AbstractMatrix3D - Class in cern.colt.matrix.impl
Abstract base class for 3-d matrices holding objects or primitive data types such as int, double, etc.
AbstractMultipleLinearRegression - Class in org.apache.commons.math.stat.regression
Abstract base class for implementations of MultipleLinearRegression.
AbstractMultipleLinearRegression() - Constructor for class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
 
AbstractRandomGenerator - Class in org.apache.commons.math.random
Abstract class implementing the RandomGenerator interface.
AbstractRandomGenerator() - Constructor for class org.apache.commons.math.random.AbstractRandomGenerator
Construct a RandomGenerator.
AbstractRealMatrix - Class in org.apache.commons.math.linear
Basic implementation of RealMatrix methods regardless of the underlying storage.
AbstractRealVector - Class in org.apache.commons.math.linear
This class provides default basic implementations for many methods in the RealVector interface.
AbstractRealVector() - Constructor for class org.apache.commons.math.linear.AbstractRealVector
 
AbstractScalarDifferentiableOptimizer - Class in org.apache.commons.math.optimization.general
Base class for implementing optimizers for multivariate scalar functions.
AbstractShortList - Class in cern.colt.list
Abstract base class for resizable lists holding short elements; abstract.
AbstractShortList - Class in cern.colt.list.tshort
Abstract base class for resizable lists holding short elements; abstract.
AbstractStepInterpolator - Class in org.apache.commons.math.ode.sampling
This abstract class represents an interpolator over the last step during an ODE integration.
AbstractStorelessUnivariateStatistic - Class in org.apache.commons.math.stat.descriptive
Abstract implementation of the StorelessUnivariateStatistic interface.
AbstractStorelessUnivariateStatistic() - Constructor for class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
 
AbstractTuple - Class in hep.aida.ref.tuple
Base class for Tuple, ChainedTuple etc.
AbstractTuple(String, String) - Constructor for class hep.aida.ref.tuple.AbstractTuple
 
AbstractTuple(String, String, String) - Constructor for class hep.aida.ref.tuple.AbstractTuple
 
AbstractTuple.AbstractTupleColumnFactory - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory() - Constructor for class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory
 
AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.BooleanTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.ByteTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.CharTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.DoubleTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.FloatTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.IntTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.ITupleTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.LongTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.ObjectTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.ShortTupleColumn - Class in hep.aida.ref.tuple
 
AbstractTuple.AbstractTupleColumnFactory.StringTupleColumn - Class in hep.aida.ref.tuple
 
AbstractUnivariateRealOptimizer - Class in org.apache.commons.math.optimization.univariate
Provide a default implementation for several functions useful to generic optimizers.
AbstractUnivariateStatistic - Class in org.apache.commons.math.stat.descriptive
Abstract base class for all implementations of the UnivariateStatistic interface.
AbstractUnivariateStatistic() - Constructor for class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
 
AbstractWell - Class in org.apache.commons.math.random
This abstract class implements the WELL class of pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
accept() - Method in class hep.aida.ref.fitter.fitdata.RangeSetFilter
 
accept() - Method in class hep.aida.ref.tuple.Filter
 
Accumulate - Class in umontreal.iro.lecuyer.simevents
A subclass of StatProbe, for collecting statistics on a variable that evolves in simulation time, with a piecewise-constant trajectory.
Accumulate() - Constructor for class umontreal.iro.lecuyer.simevents.Accumulate
Constructs a new Accumulate statistical probe using the default simulator and initializes it by invoking init().
Accumulate(Simulator) - Constructor for class umontreal.iro.lecuyer.simevents.Accumulate
Constructs a new Accumulate statistical probe linked to the given simulator, and initializes it by invoking init().
Accumulate(String) - Constructor for class umontreal.iro.lecuyer.simevents.Accumulate
Construct and initializes a new Accumulate statistical probe with name name and initial time 0, using the default simulator.
Accumulate(Simulator, String) - Constructor for class umontreal.iro.lecuyer.simevents.Accumulate
Construct and initializes a new Accumulate statistical probe with name name and initial time 0.
acos - Static variable in class cern.jet.math.Functions
Function that returns Math.acos(a).
acos(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
acos - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
acos - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.acos(a).
acos(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
acos - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
acos - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.acos(a).
acos(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
acos(double) - Static method in class flanagan.math.Fmath
 
acos(ValueErr) - Static method in class jhplot.math.ValueErr
Inverse cosine of a value with error
ACOS - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.abs method wrapped as a ComposableFunction.
acos() - Method in class org.apache.commons.math.complex.Complex
Compute the inverse cosine of this complex number.
acos(Dfp) - Static method in class org.apache.commons.math.dfp.DfpMath
computes the arc-cosine of the argument.
acos(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the arc cosine of a number.
acosh(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
acosh(double) - Static method in class flanagan.math.Fmath
 
acosh(double) - Static method in class jhplot.math.num.special.Trigonometric
Returns the inverse hyperbolic cosine of x.
acosh(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the inverse hyperbolic cosine of a number.
acot(double) - Static method in class flanagan.math.Fmath
 
acot2(double, double) - Static method in class flanagan.math.Fmath
 
acoth(double) - Static method in class flanagan.math.Fmath
 
acovers(double) - Static method in class flanagan.math.Fmath
 
acsc(double) - Static method in class flanagan.math.Fmath
 
acsch(double) - Static method in class flanagan.math.Fmath
 
action(Event, Object) - Method in class jhplot.bsom.Bsom
 
action(Event, Object) - Method in class jhplot.bsom.BsomDemo
 
actionPerformed(ActionEvent) - Method in class jhplot.v3d.Editor3d
 
actionPerformed(ActionEvent) - Method in class jhpro.stat.limit.LimitCalculatorGui
 
actionPerformed(ActionEvent) - Method in class jhpro.stat.limit.LimitCalculatorGui.myFrame
 
actions() - Method in class umontreal.iro.lecuyer.simevents.Event
This is the method that is executed when this event occurs.
actions() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
This is the method that is called when this process is executing.
activeTests - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
The set of EDF tests that are to be performed when calling the methods activeTests, formatActiveTests, etc.
activeTests(DoubleArrayList, double[], double[]) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Computes the EDF test statistics by calling tests, then computes the p-values of those that currently belong to activeTests, and return these quantities in sVal and pVal, respectively.
activeTests(DoubleArrayList, ContinuousDistribution, double[], double[]) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
The observations are in data, not necessarily sorted, and we want to compare their empirical distribution with the distribution dist.
AD - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Anderson-Darling test
AdamsBashforthIntegrator - Class in org.apache.commons.math.ode.nonstiff
This class implements explicit Adams-Bashforth integrators for Ordinary Differential Equations.
AdamsBashforthIntegrator(int, double, double, double, double) - Constructor for class org.apache.commons.math.ode.nonstiff.AdamsBashforthIntegrator
Build an Adams-Bashforth integrator with the given order and step control parameters.
AdamsBashforthIntegrator(int, double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.nonstiff.AdamsBashforthIntegrator
Build an Adams-Bashforth integrator with the given order and step control parameters.
AdamsIntegrator - Class in org.apache.commons.math.ode.nonstiff
Base class for Adams-Bashforth and Adams-Moulton integrators.
AdamsIntegrator(String, int, int, double, double, double, double) - Constructor for class org.apache.commons.math.ode.nonstiff.AdamsIntegrator
Build an Adams integrator with the given order and step control prameters.
AdamsIntegrator(String, int, int, double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.nonstiff.AdamsIntegrator
Build an Adams integrator with the given order and step control parameters.
AdamsMoultonIntegrator - Class in org.apache.commons.math.ode.nonstiff
This class implements implicit Adams-Moulton integrators for Ordinary Differential Equations.
AdamsMoultonIntegrator(int, double, double, double, double) - Constructor for class org.apache.commons.math.ode.nonstiff.AdamsMoultonIntegrator
Build an Adams-Moulton integrator with the given order and error control parameters.
AdamsMoultonIntegrator(int, double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.nonstiff.AdamsMoultonIntegrator
Build an Adams-Moulton integrator with the given order and error control parameters.
AdamsNordsieckTransformer - Class in org.apache.commons.math.ode.nonstiff
Transformer to Nordsieck vectors for Adams integrators.
adaptive(F1D, double, double) - Static method in class jhplot.math.Numeric
In adaptive quadrature we estimate the area under a curve in the interval from a to b twice, one using Q1 and once using Q2.
AdaptiveIntegrator - Class in jhplot.math.num.integration
An implementation of adaptive quadrature.
AdaptiveIntegrator(Function) - Constructor for class jhplot.math.num.integration.AdaptiveIntegrator
Create an integrator for the given function.
AdaptiveIntegrator(Function, int, double) - Constructor for class jhplot.math.num.integration.AdaptiveIntegrator
Create an integrator for the given function.
AdaptiveStepsizeIntegrator - Class in org.apache.commons.math.ode.nonstiff
This abstract class holds the common part of all adaptive stepsize integrators for Ordinary Differential Equations.
AdaptiveStepsizeIntegrator(String, double, double, double, double) - Constructor for class org.apache.commons.math.ode.nonstiff.AdaptiveStepsizeIntegrator
Build an integrator with the given stepsize bounds.
AdaptiveStepsizeIntegrator(String, double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.nonstiff.AdaptiveStepsizeIntegrator
Build an integrator with the given stepsize bounds.
add(double) - Method in class cern.colt.buffer.DoubleBuffer
Adds the specified element to the receiver.
add(double, double) - Method in class cern.colt.buffer.DoubleBuffer2D
Adds the specified point (x,y) to the receiver.
add(double, double, double) - Method in class cern.colt.buffer.DoubleBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(int) - Method in class cern.colt.buffer.IntBuffer
Adds the specified element to the receiver.
add(int, int) - Method in class cern.colt.buffer.IntBuffer2D
Adds the specified point (x,y) to the receiver.
add(int, int, int) - Method in class cern.colt.buffer.IntBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(Object) - Method in class cern.colt.buffer.ObjectBuffer
Adds the specified element to the receiver.
add(boolean) - Method in class cern.colt.buffer.tboolean.BooleanBuffer
Adds the specified element to the receiver.
add(boolean, boolean) - Method in class cern.colt.buffer.tboolean.BooleanBuffer2D
Adds the specified point (x,y) to the receiver.
add(boolean, boolean, boolean) - Method in class cern.colt.buffer.tboolean.BooleanBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(byte) - Method in class cern.colt.buffer.tbyte.ByteBuffer
Adds the specified element to the receiver.
add(byte, byte) - Method in class cern.colt.buffer.tbyte.ByteBuffer2D
Adds the specified point (x,y) to the receiver.
add(byte, byte, byte) - Method in class cern.colt.buffer.tbyte.ByteBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(char) - Method in class cern.colt.buffer.tchar.CharBuffer
Adds the specified element to the receiver.
add(char, char) - Method in class cern.colt.buffer.tchar.CharBuffer2D
Adds the specified point (x,y) to the receiver.
add(char, char, char) - Method in class cern.colt.buffer.tchar.CharBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(double) - Method in class cern.colt.buffer.tdouble.DoubleBuffer
Adds the specified element to the receiver.
add(double, double) - Method in class cern.colt.buffer.tdouble.DoubleBuffer2D
Adds the specified point (x,y) to the receiver.
add(double, double, double) - Method in class cern.colt.buffer.tdouble.DoubleBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(float) - Method in class cern.colt.buffer.tfloat.FloatBuffer
Adds the specified element to the receiver.
add(float, float) - Method in class cern.colt.buffer.tfloat.FloatBuffer2D
Adds the specified point (x,y) to the receiver.
add(float, float, float) - Method in class cern.colt.buffer.tfloat.FloatBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(int) - Method in class cern.colt.buffer.tint.IntBuffer
Adds the specified element to the receiver.
add(int, int) - Method in class cern.colt.buffer.tint.IntBuffer2D
Adds the specified point (x,y) to the receiver.
add(int, int, int) - Method in class cern.colt.buffer.tint.IntBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(long) - Method in class cern.colt.buffer.tlong.LongBuffer
Adds the specified element to the receiver.
add(long, long) - Method in class cern.colt.buffer.tlong.LongBuffer2D
Adds the specified point (x,y) to the receiver.
add(long, long, long) - Method in class cern.colt.buffer.tlong.LongBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(Object) - Method in class cern.colt.buffer.tobject.ObjectBuffer
Adds the specified element to the receiver.
add(short) - Method in class cern.colt.buffer.tshort.ShortBuffer
Adds the specified element to the receiver.
add(short, short) - Method in class cern.colt.buffer.tshort.ShortBuffer2D
Adds the specified point (x,y) to the receiver.
add(short, short, short) - Method in class cern.colt.buffer.tshort.ShortBuffer3D
Adds the specified point (x,y,z) to the receiver.
add(boolean) - Method in class cern.colt.list.AbstractBooleanList
Appends the specified element to the end of this list.
add(byte) - Method in class cern.colt.list.AbstractByteList
Appends the specified element to the end of this list.
add(char) - Method in class cern.colt.list.AbstractCharList
Appends the specified element to the end of this list.
add(double) - Method in class cern.colt.list.AbstractDoubleList
Appends the specified element to the end of this list.
add(float) - Method in class cern.colt.list.AbstractFloatList
Appends the specified element to the end of this list.
add(int) - Method in class cern.colt.list.AbstractIntList
Appends the specified element to the end of this list.
add(long) - Method in class cern.colt.list.AbstractLongList
Appends the specified element to the end of this list.
add(short) - Method in class cern.colt.list.AbstractShortList
Appends the specified element to the end of this list.
add(int, Object) - Method in class cern.colt.list.adapter.DoubleListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(int, Object) - Method in class cern.colt.list.adapter.FloatListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(int, Object) - Method in class cern.colt.list.adapter.IntListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(int, Object) - Method in class cern.colt.list.adapter.LongListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(int, Object) - Method in class cern.colt.list.adapter.ObjectListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(boolean) - Method in class cern.colt.list.BooleanArrayList
Appends the specified element to the end of this list.
add(byte) - Method in class cern.colt.list.ByteArrayList
Appends the specified element to the end of this list.
add(char) - Method in class cern.colt.list.CharArrayList
Appends the specified element to the end of this list.
add(long) - Method in class cern.colt.list.DistinctNumberList
Appends the specified element to the end of this list.
add(double) - Method in class cern.colt.list.DoubleArrayList
Appends the specified element to the end of this list.
add(float) - Method in class cern.colt.list.FloatArrayList
Appends the specified element to the end of this list.
add(int) - Method in class cern.colt.list.IntArrayList
Appends the specified element to the end of this list.
add(long) - Method in class cern.colt.list.LongArrayList
Appends the specified element to the end of this list.
add(long) - Method in class cern.colt.list.MinMaxNumberList
Appends the specified element to the end of this list.
add(Object) - Method in class cern.colt.list.ObjectArrayList
Appends the specified element to the end of this list.
add(short) - Method in class cern.colt.list.ShortArrayList
Appends the specified element to the end of this list.
add(boolean) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Appends the specified element to the end of this list.
add(boolean) - Method in class cern.colt.list.tboolean.BooleanArrayList
Appends the specified element to the end of this list.
add(byte) - Method in class cern.colt.list.tbyte.AbstractByteList
Appends the specified element to the end of this list.
add(byte) - Method in class cern.colt.list.tbyte.ByteArrayList
Appends the specified element to the end of this list.
add(char) - Method in class cern.colt.list.tchar.AbstractCharList
Appends the specified element to the end of this list.
add(char) - Method in class cern.colt.list.tchar.CharArrayList
Appends the specified element to the end of this list.
add(double) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Appends the specified element to the end of this list.
add(double) - Method in class cern.colt.list.tdouble.DoubleArrayList
Appends the specified element to the end of this list.
add(int, Object) - Method in class cern.colt.list.tdouble.DoubleListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(float) - Method in class cern.colt.list.tfloat.AbstractFloatList
Appends the specified element to the end of this list.
add(float) - Method in class cern.colt.list.tfloat.FloatArrayList
Appends the specified element to the end of this list.
add(int, Object) - Method in class cern.colt.list.tfloat.FloatListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(int) - Method in class cern.colt.list.tint.AbstractIntList
Appends the specified element to the end of this list.
add(int) - Method in class cern.colt.list.tint.IntArrayList
Appends the specified element to the end of this list.
add(int, Object) - Method in class cern.colt.list.tint.IntListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(long) - Method in class cern.colt.list.tlong.AbstractLongList
Appends the specified element to the end of this list.
add(long) - Method in class cern.colt.list.tlong.DistinctNumberList
Appends the specified element to the end of this list.
add(long) - Method in class cern.colt.list.tlong.LongArrayList
Appends the specified element to the end of this list.
add(int, Object) - Method in class cern.colt.list.tlong.LongListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(long) - Method in class cern.colt.list.tlong.MinMaxNumberList
Appends the specified element to the end of this list.
add(Object) - Method in class cern.colt.list.tobject.ObjectArrayList
Appends the specified element to the end of this list.
add(int, Object) - Method in class cern.colt.list.tobject.ObjectListAdapter
Inserts the specified element at the specified position in this list (optional operation).
add(short) - Method in class cern.colt.list.tshort.AbstractShortList
Appends the specified element to the end of this list.
add(short) - Method in class cern.colt.list.tshort.ShortArrayList
Appends the specified element to the end of this list.
add(int, int[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Shifts the indexes.
add(int, int[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Shifts the indexes.
add(double) - Method in class cern.hep.aida.bin.AbstractBin1D
Adds the specified element to the receiver.
add(double) - Method in class cern.hep.aida.bin.DynamicBin1D
Adds the specified element to the receiver.
add(double) - Method in class cern.hep.aida.bin.StaticBin1D
Adds the specified element to the receiver.
add(double) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Adds a value to the receiver.
add(double) - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Adds a value to the receiver.
add(double) - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Adds a value to the receiver.
add(double) - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Adds a value to the receiver.
add(float) - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Adds a value to the receiver.
add(String, IFunction) - Method in class hep.aida.ref.function.FunctionCatalog
 
add(String, String) - Method in class hep.aida.ref.function.FunctionCatalog
 
add(Binner1D, Binner1D, Binner1D) - Static method in class hep.aida.ref.histogram.binner.BinnerMath
 
add(String, IDataPointSet, IDataPointSet) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
add(IHistogram1D) - Method in class hep.aida.ref.histogram.Histogram1D
Modifies this histogram by adding the contents of h to it.
add(IHistogram2D) - Method in class hep.aida.ref.histogram.Histogram2D
Modifies this histogram by adding the contents of h to it.
add(IHistogram3D) - Method in class hep.aida.ref.histogram.Histogram3D
Modifies this histogram by adding the contents of h to it.
add(String, IHistogram1D, IHistogram1D) - Method in class hep.aida.ref.histogram.HistogramFactory
Adds two 1D Histogram
add(String, IHistogram2D, IHistogram2D) - Method in class hep.aida.ref.histogram.HistogramFactory
Adds two 2D Histogram
add(String, IHistogram3D, IHistogram3D) - Method in class hep.aida.ref.histogram.HistogramFactory
Adds two 3D Histogram
add(IProfile1D) - Method in class hep.aida.ref.histogram.Profile1D
 
add(IProfile2D) - Method in class hep.aida.ref.histogram.Profile2D
 
add(String, IManagedObject) - Method in class hep.aida.ref.tree.Tree
This "add" method is called from the IStore, and can create new folders if it is needed.
add(double) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Adds the specified element to the receiver.
add(double) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Adds the specified element to the receiver.
add(double) - Method in class hep.aida.tdouble.bin.StaticDoubleBin1D
Adds the specified element to the receiver.
add(float) - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Adds the specified element to the receiver.
add(float) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Adds the specified element to the receiver.
add(float) - Method in class hep.aida.tfloat.bin.StaticFloatBin1D
Adds the specified element to the receiver.
add(HEParticle) - Method in class hephysics.particle.HEParticle
Add 2 particles
add(LParticle) - Method in class hephysics.particle.LParticle
Add 2 particle
add(Hep3Vector, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Add 2 vectors and return a new object
add(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Add a vector
add(HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Add 2 Lorentz vectors
add(HepLorentzVector, HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Add 2 vectors
add(Hep3Vector, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
add(int, H1D) - Method in class jhplot.HBook
add H1D histogram to HBook
add(int, H2D) - Method in class jhplot.HBook
add H2D histogram to HBook
add(int, P1D) - Method in class jhplot.HBook
add P1D histogram to HBook
add(HLabel) - Method in class jhplot.HPlot
Add a label to the Canvas.
add(HKey) - Method in class jhplot.HPlot
Add a key to the Canvas.
add(HMLabel) - Method in class jhplot.HPlot
Add a multiline label to the Canvas.
add(HLabelEq) - Method in class jhplot.HPlot
Add a LaTeX equation to the canvas.
add(HShape) - Method in class jhplot.HPlot
Add a shape primitive to the Canvas.
add(HLabel, double) - Method in class jhplot.HPlot2D
Add a label to the Canvas in NDC coordinates
add(JaObject) - Method in class jhplot.HPlotJa
Add an object to the frame.
add(ConstructionObject) - Method in class jhplot.HZirkel
Add an object on the canvas and update it.
add(double[], double, double[], int) - Static method in class jhplot.math.ArrayMathUtils
Adds to an array w, a times v where a is a scalar.
add(double[], double) - Static method in class jhplot.math.ArrayMathUtils
Adds a scalar to every element in the array.
add(double[], double[]) - Static method in class jhplot.math.ArrayMathUtils
Adds the two arrays together (componentwise).
add(int[], double, int[], int) - Static method in class jhplot.math.ArrayMathUtils
Adds to an array w, a times v where a is a scalar.
add(int[], int) - Static method in class jhplot.math.ArrayMathUtils
Adds a scalar to every element in the array.
add(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Adds the two arrays together (componentwise).
add(double[][], double) - Static method in class jhplot.math.DoubleArray
Adds a single value to a matrix, e.g.
add(double[][], double[][]) - Static method in class jhplot.math.DoubleArray
Adds a matrix to another matrix, which should be of the same dimension.
add(double) - Method in class jhplot.math.num.DoubleArray
Adds an element to the end of this expandable array.
add(double) - Method in class jhplot.P0D
Adds (appends) the specified element to the end of this list.
add(int) - Method in class jhplot.P0D
Adds (appends) the specified element to the end of this list.
add(Integer) - Method in class jhplot.P0I
Adds (appends) the specified element to the end of this list.
add(int) - Method in class jhplot.P0I
Adds (appends) the specified element to the end of this list.
add(double, double) - Method in class jhplot.P1D
Adds values of a plot-point pair (X,Y).
add(double, double, double) - Method in class jhplot.P1D
Adds the values of a plot-point pair (X,Y).
add(double, double, double, double) - Method in class jhplot.P1D
Add values of a plot-point pair (X,Y).
add(double, double, double, double, double, double) - Method in class jhplot.P1D
Adds the values of a plot-point pair (X,Y).
add(double, double, double, double, double, double, double, double, double, double) - Method in class jhplot.P1D
Adds the values of a plot-point pair (x,y).
add(double, double, double) - Method in class jhplot.P2D
Adds values of a plot-point pair (X,Y,Z).
add(double, double, double, double, double, double) - Method in class jhplot.P3D
Adds values of a plot-point pair (X,dX,Y,dY,Z,dZ).
add(double[]) - Method in class jhplot.PND
Adds (appends) the specified element to the end of this list.
add(P0D) - Method in class jhplot.PND
Adds (appends) P0D to the end of this list.
add(int[]) - Method in class jhplot.PNI
Adds (appends) the specified element to the end of this list.
add(P0I) - Method in class jhplot.PNI
Adds (appends) P0D to the end of this list.
add(Vector3d) - Method in class jhplot.v3d.Vector3d
 
add(DataPoint) - Method in class jminhep.cluster.DataHolder
Add a data point to the holder
add(double[]) - Method in class jminhep.cluster.DataHolder
Add a new instance to data holder in form of array
ADD - Static variable in class org.apache.commons.math.analysis.BinaryFunction
Deprecated. The + operator method wrapped as a BinaryFunction.
add(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.ComposableFunction
Return a function adding the instance and another function.
add(double) - Method in class org.apache.commons.math.analysis.ComposableFunction
Return a function adding a constant term to the instance.
add(PolynomialFunction) - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Add a polynomial to the instance.
add(Complex) - Method in class org.apache.commons.math.complex.Complex
Return the sum of this complex number and the given complex number.
add(Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Add x to this.
add(T) - Method in interface org.apache.commons.math.FieldElement
Compute this + a.
add(BigInteger) - Method in class org.apache.commons.math.fraction.BigFraction
Adds the value of this fraction to the passed BigInteger, returning the result in reduced form.
add(int) - Method in class org.apache.commons.math.fraction.BigFraction
Adds the value of this fraction to the passed integer, returning the result in reduced form.
add(long) - Method in class org.apache.commons.math.fraction.BigFraction
Adds the value of this fraction to the passed long, returning the result in reduced form.
add(BigFraction) - Method in class org.apache.commons.math.fraction.BigFraction
Adds the value of this fraction to another, returning the result in reduced form.
add(Fraction) - Method in class org.apache.commons.math.fraction.Fraction
Adds the value of this fraction to another, returning the result in reduced form.
add(int) - Method in class org.apache.commons.math.fraction.Fraction
Add an integer to the fraction.
add(Vector3D) - Method in class org.apache.commons.math.geometry.Vector3D
Add a vector to the instance.
add(double, Vector3D) - Method in class org.apache.commons.math.geometry.Vector3D
Add a scaled vector to the instance.
add(FieldMatrix<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Compute the sum of this and m.
add(RealMatrix) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Compute the sum of this and m.
add(double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Compute the sum of this vector and v.
add(RealVector) - Method in class org.apache.commons.math.linear.AbstractRealVector
Compute the sum of this vector and v.
add(FieldMatrix<T>) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Compute the sum of this and m.
add(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Compute the sum of this and m.
add(RealMatrix) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Compute the sum of this and m.
add(Array2DRowRealMatrix) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Compute the sum of this and m.
add(FieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute the sum of this and v.
add(T[]) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute the sum of this and v.
add(ArrayFieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute the sum of this and v.
add(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Compute the sum of this vector and v.
add(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Compute the sum of this vector and v.
add(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Compute the sum of this and v.
add(BigMatrix) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Compute the sum of this and m.
add(BigMatrix) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Compute the sum of this and m.
add(BigMatrixImpl) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Compute the sum of this and m.
add(FieldMatrix<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Compute the sum of this and m.
add(BlockFieldMatrix<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Compute the sum of this and m.
add(RealMatrix) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Compute the sum of this and m.
add(BlockRealMatrix) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Compute the sum of this and m.
add(FieldMatrix<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Compute the sum of this and m.
add(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldVector
Compute the sum of this and v.
add(T[]) - Method in interface org.apache.commons.math.linear.FieldVector
Compute the sum of this and v.
add(RealMatrix) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Compute the sum of this and m.
add(OpenMapRealMatrix) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Compute the sum of this and m.
add(RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Compute the sum of this vector and v.
add(OpenMapRealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Optimized method to add two OpenMapRealVectors.
add(RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Compute the sum of this and m.
add(RealMatrix) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Compute the sum of this and m.
add(RealMatrixImpl) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Compute the sum of this and m.
add(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Compute the sum of this vector and v.
add(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Compute the sum of this vector and v.
add(SparseFieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Optimized method to add sparse vectors.
add(T[]) - Method in class org.apache.commons.math.linear.SparseFieldVector
Compute the sum of this and v.
add(FieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Compute the sum of this and v.
add(BigReal) - Method in class org.apache.commons.math.util.BigReal
Compute this + a.
add(double[]) - Method in class umontreal.iro.lecuyer.charts.BoxChart
Adds a data series into the series collection.
add(double[], int) - Method in class umontreal.iro.lecuyer.charts.BoxChart
Adds a data series into the series collection.
add(double[]) - Method in class umontreal.iro.lecuyer.charts.BoxSeriesCollection
Adds a data series into the series collection.
add(double[], int) - Method in class umontreal.iro.lecuyer.charts.BoxSeriesCollection
Adds a data series into the series collection.
add(double[]) - Method in class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Adds a data series into the series collection.
add(double[], int) - Method in class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Adds a data series into the series collection.
add(DoubleArrayList) - Method in class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Adds a data series into the series collection.
add(TallyStore) - Method in class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Adds a data series into the series collection.
add(double[]) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Adds a data series into the series collection.
add(double[], int) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Adds a data series into the series collection.
add(DoubleArrayList) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Adds a data series into the series collection.
add(TallyStore) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Adds a data series into the series collection.
add(SSJXYSeriesCollection) - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Adds a new dataset to the chart at the end of the list and returns its position.
add(double[], double[], String, String) - Method in class umontreal.iro.lecuyer.charts.ScatterChart
Adds a data series into the series collection.
add(double[], double[]) - Method in class umontreal.iro.lecuyer.charts.ScatterChart
Adds a data series into the series collection.
add(double[], double[], int) - Method in class umontreal.iro.lecuyer.charts.ScatterChart
Adds a data series into the series collection.
add(double[], double[], String, String) - Method in class umontreal.iro.lecuyer.charts.XYLineChart
Adds a data series into the series collection.
add(double[], double[]) - Method in class umontreal.iro.lecuyer.charts.XYLineChart
Adds a data series into the series collection.
add(double[], double[], int) - Method in class umontreal.iro.lecuyer.charts.XYLineChart
Adds a data series into the series collection.
add(double[][]) - Method in class umontreal.iro.lecuyer.charts.XYLineChart
Adds the new collection of data series data into the series collection.
add(double[][], int) - Method in class umontreal.iro.lecuyer.charts.XYLineChart
Adds the new collection of data series data into the series collection.
add(double[], double[]) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Adds a data series into the series collection.
add(double[], double[], int) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Adds a data series into the series collection.
add(double[][]) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Adds a data series into the series collection.
add(double[][], int) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Adds data series into the series collection.
add(DoubleArrayList) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Adds a data series into the series collection.
add(RandomStream) - Method in class umontreal.iro.lecuyer.rng.RandomStreamManager
Adds the given stream to the internal list of this random stream manager and returns the added stream.
add(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
add(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
add(Event) - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Adds a new event in the event list, according to the time of ev.
add(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
add(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
add(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
add(int, E) - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
 
add(E) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
add(int, E) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
add(double[]) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
Adds the observation x[i] in tally i of this list, for i = 0, ..., size() - 1.
add(double[]) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTalliesWithCovariance
Adds a new vector of observations x to this list of tallies, and updates the internal data structures computing averages, and sums of products.
add(DoubleMatrix1D) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTalliesWithCovariance
 
add(double) - Method in class umontreal.iro.lecuyer.stat.Tally
Gives a new observation x to the statistical collector.
add(double) - Method in class umontreal.iro.lecuyer.stat.TallyStore
 
add(int, OE) - Method in class umontreal.iro.lecuyer.util.TransformingList
 
addAfter(Event, Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
addAfter(Event, Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
addAfter(Event, Event) - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Same as add, but adds the new event ev immediately after the event other in the list.
addAfter(Event, Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
addAfter(Event, Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
addAfter(Event, Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
addAll(Collection<? extends E>) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
addAll(int, Collection<? extends E>) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
addAllOf(DoubleArrayList) - Method in class cern.colt.buffer.DoubleBuffer
Adds all elements of the specified list to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList) - Method in class cern.colt.buffer.DoubleBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList) - Method in interface cern.colt.buffer.DoubleBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList, DoubleArrayList) - Method in class cern.colt.buffer.DoubleBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList, DoubleArrayList) - Method in interface cern.colt.buffer.DoubleBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(DoubleArrayList) - Method in interface cern.colt.buffer.DoubleBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(IntArrayList) - Method in class cern.colt.buffer.IntBuffer
Adds all elements of the specified list to the receiver.
addAllOf(IntArrayList, IntArrayList) - Method in class cern.colt.buffer.IntBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(IntArrayList, IntArrayList) - Method in interface cern.colt.buffer.IntBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.buffer.IntBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(IntArrayList, IntArrayList, IntArrayList) - Method in interface cern.colt.buffer.IntBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(IntArrayList) - Method in interface cern.colt.buffer.IntBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(ObjectArrayList) - Method in class cern.colt.buffer.ObjectBuffer
Adds all elements of the specified list to the receiver.
addAllOf(ObjectArrayList) - Method in interface cern.colt.buffer.ObjectBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(BooleanArrayList) - Method in class cern.colt.buffer.tboolean.BooleanBuffer
Adds all elements of the specified list to the receiver.
addAllOf(BooleanArrayList, BooleanArrayList) - Method in class cern.colt.buffer.tboolean.BooleanBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(BooleanArrayList, BooleanArrayList) - Method in interface cern.colt.buffer.tboolean.BooleanBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(BooleanArrayList, BooleanArrayList, BooleanArrayList) - Method in class cern.colt.buffer.tboolean.BooleanBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(BooleanArrayList, BooleanArrayList, BooleanArrayList) - Method in interface cern.colt.buffer.tboolean.BooleanBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(BooleanArrayList) - Method in interface cern.colt.buffer.tboolean.BooleanBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(ByteArrayList) - Method in class cern.colt.buffer.tbyte.ByteBuffer
Adds all elements of the specified list to the receiver.
addAllOf(ByteArrayList, ByteArrayList) - Method in class cern.colt.buffer.tbyte.ByteBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(ByteArrayList, ByteArrayList) - Method in interface cern.colt.buffer.tbyte.ByteBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(ByteArrayList, ByteArrayList, ByteArrayList) - Method in class cern.colt.buffer.tbyte.ByteBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(ByteArrayList, ByteArrayList, ByteArrayList) - Method in interface cern.colt.buffer.tbyte.ByteBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(ByteArrayList) - Method in interface cern.colt.buffer.tbyte.ByteBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(CharArrayList) - Method in class cern.colt.buffer.tchar.CharBuffer
Adds all elements of the specified list to the receiver.
addAllOf(CharArrayList, CharArrayList) - Method in class cern.colt.buffer.tchar.CharBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(CharArrayList, CharArrayList) - Method in interface cern.colt.buffer.tchar.CharBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(CharArrayList, CharArrayList, CharArrayList) - Method in class cern.colt.buffer.tchar.CharBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(CharArrayList, CharArrayList, CharArrayList) - Method in interface cern.colt.buffer.tchar.CharBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(CharArrayList) - Method in interface cern.colt.buffer.tchar.CharBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(DoubleArrayList) - Method in class cern.colt.buffer.tdouble.DoubleBuffer
Adds all elements of the specified list to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList) - Method in class cern.colt.buffer.tdouble.DoubleBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList) - Method in interface cern.colt.buffer.tdouble.DoubleBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList, DoubleArrayList) - Method in class cern.colt.buffer.tdouble.DoubleBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(DoubleArrayList, DoubleArrayList, DoubleArrayList) - Method in interface cern.colt.buffer.tdouble.DoubleBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(DoubleArrayList) - Method in interface cern.colt.buffer.tdouble.DoubleBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(FloatArrayList) - Method in class cern.colt.buffer.tfloat.FloatBuffer
Adds all elements of the specified list to the receiver.
addAllOf(FloatArrayList, FloatArrayList) - Method in class cern.colt.buffer.tfloat.FloatBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(FloatArrayList, FloatArrayList) - Method in interface cern.colt.buffer.tfloat.FloatBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(FloatArrayList, FloatArrayList, FloatArrayList) - Method in class cern.colt.buffer.tfloat.FloatBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(FloatArrayList, FloatArrayList, FloatArrayList) - Method in interface cern.colt.buffer.tfloat.FloatBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(FloatArrayList) - Method in interface cern.colt.buffer.tfloat.FloatBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(IntArrayList) - Method in class cern.colt.buffer.tint.IntBuffer
Adds all elements of the specified list to the receiver.
addAllOf(IntArrayList, IntArrayList) - Method in class cern.colt.buffer.tint.IntBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(IntArrayList, IntArrayList) - Method in interface cern.colt.buffer.tint.IntBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.buffer.tint.IntBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(IntArrayList, IntArrayList, IntArrayList) - Method in interface cern.colt.buffer.tint.IntBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(IntArrayList) - Method in interface cern.colt.buffer.tint.IntBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(LongArrayList) - Method in class cern.colt.buffer.tlong.LongBuffer
Adds all elements of the specified list to the receiver.
addAllOf(LongArrayList, LongArrayList) - Method in class cern.colt.buffer.tlong.LongBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(LongArrayList, LongArrayList) - Method in interface cern.colt.buffer.tlong.LongBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(LongArrayList, LongArrayList, LongArrayList) - Method in class cern.colt.buffer.tlong.LongBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(LongArrayList, LongArrayList, LongArrayList) - Method in interface cern.colt.buffer.tlong.LongBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(LongArrayList) - Method in interface cern.colt.buffer.tlong.LongBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(ObjectArrayList) - Method in class cern.colt.buffer.tobject.ObjectBuffer
Adds all elements of the specified list to the receiver.
addAllOf(ObjectArrayList) - Method in interface cern.colt.buffer.tobject.ObjectBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(ShortArrayList) - Method in class cern.colt.buffer.tshort.ShortBuffer
Adds all elements of the specified list to the receiver.
addAllOf(ShortArrayList, ShortArrayList) - Method in class cern.colt.buffer.tshort.ShortBuffer2D
Adds all specified points (x,y) to the receiver.
addAllOf(ShortArrayList, ShortArrayList) - Method in interface cern.colt.buffer.tshort.ShortBuffer2DConsumer
Adds all specified (x,y) points to the receiver.
addAllOf(ShortArrayList, ShortArrayList, ShortArrayList) - Method in class cern.colt.buffer.tshort.ShortBuffer3D
Adds all specified (x,y,z) points to the receiver.
addAllOf(ShortArrayList, ShortArrayList, ShortArrayList) - Method in interface cern.colt.buffer.tshort.ShortBuffer3DConsumer
Adds all specified (x,y,z) points to the receiver.
addAllOf(ShortArrayList) - Method in interface cern.colt.buffer.tshort.ShortBufferConsumer
Adds all elements of the specified list to the receiver.
addAllOf(DoubleArrayList) - Method in class cern.colt.list.AbstractDoubleList
Appends all elements of the specified list to the receiver.
addAllOf(IntArrayList) - Method in class cern.colt.list.AbstractIntList
Appends all elements of the specified list to the receiver.
addAllOf(Collection) - Method in class cern.colt.list.AbstractList
Appends all of the elements of the specified Collection to the receiver.
addAllOf(DoubleArrayList) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Appends all elements of the specified list to the receiver.
addAllOf(FloatArrayList) - Method in class cern.colt.list.tfloat.AbstractFloatList
Appends all elements of the specified list to the receiver.
addAllOf(IntArrayList) - Method in class cern.colt.list.tint.AbstractIntList
Appends all elements of the specified list to the receiver.
addAllOf(DoubleArrayList) - Method in class cern.hep.aida.bin.AbstractBin1D
Adds all values of the specified list to the receiver.
addAllOf(DoubleArrayList) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Adds all values of the specified list to the receiver.
addAllOf(DoubleArrayList) - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Adds all values of the specified list to the receiver.
addAllOf(DoubleArrayList) - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Adds all values of the specified list to the receiver.
addAllOf(FloatArrayList) - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Adds all values of the specified list to the receiver.
addAllOf(DoubleArrayList) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Adds all values of the specified list to the receiver.
addAllOf(FloatArrayList) - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Adds all values of the specified list to the receiver.
addAllOfFromTo(AbstractBooleanList, int, int) - Method in class cern.colt.list.AbstractBooleanList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractByteList, int, int) - Method in class cern.colt.list.AbstractByteList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractCharList, int, int) - Method in class cern.colt.list.AbstractCharList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractDoubleList, int, int) - Method in class cern.colt.list.AbstractDoubleList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractFloatList, int, int) - Method in class cern.colt.list.AbstractFloatList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractIntList, int, int) - Method in class cern.colt.list.AbstractIntList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractLongList, int, int) - Method in class cern.colt.list.AbstractLongList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractShortList, int, int) - Method in class cern.colt.list.AbstractShortList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(long[], int, int) - Method in class cern.colt.list.MinMaxNumberList
Appends the elements elements[from] (inclusive), ..., elements[to] (inclusive) to the receiver.
addAllOfFromTo(ObjectArrayList, int, int) - Method in class cern.colt.list.ObjectArrayList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractBooleanList, int, int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractByteList, int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractCharList, int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractDoubleList, int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractFloatList, int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractIntList, int, int) - Method in class cern.colt.list.tint.AbstractIntList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractLongList, int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(long[], int, int) - Method in class cern.colt.list.tlong.MinMaxNumberList
Appends the elements elements[from] (inclusive), ..., elements[to] (inclusive) to the receiver.
addAllOfFromTo(ObjectArrayList, int, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(AbstractShortList, int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Appends the part of the specified list between from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.hep.aida.bin.AbstractBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.hep.aida.bin.DynamicBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.hep.aida.bin.MightyStaticBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.hep.aida.bin.QuantileBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.hep.aida.bin.StaticBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Adds a value to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(FloatArrayList, int, int) - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(DoubleArrayList, int, int) - Method in class hep.aida.tdouble.bin.StaticDoubleBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(FloatArrayList, int, int) - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(FloatArrayList, int, int) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(FloatArrayList, int, int) - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(FloatArrayList, int, int) - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAllOfFromTo(FloatArrayList, int, int) - Method in class hep.aida.tfloat.bin.StaticFloatBin1D
Adds the part of the specified list between indexes from (inclusive) and to (inclusive) to the receiver.
addAndAverage(P1D[]) - Method in class jhplot.P1D
Return P1D array with weighted average of several measurements.
addAndCheck(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Add two integers, checking for overflow.
addAndCheck(long, long) - Static method in class org.apache.commons.math.util.MathUtils
Add two long integers, checking for overflow.
addArrayOfObservationListener(ArrayOfObservationListener) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Adds the observation listener l to the list of observers of this list of statistical probes.
addBefore(Event, Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
addBefore(Event, Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
addBefore(Event, Event) - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Same as add, but adds the new event ev immediately before the event other in the list.
addBefore(Event, Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
addBefore(Event, Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
addBefore(Event, Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
addChannel(H1D, H1D, H1D) - Method in class jhpro.stat.DataSource
Adds a channel with signal, background and data given as input.
addChannel(P1D, P1D, P1D) - Method in class jhpro.stat.DataSource
Adds a channel with signal, background and data given as input.
addChannel(DataKeeper, DataKeeper, DataKeeper, double, double, double, String) - Method in class jhpro.stat.DataSource
Adds a channel with signal, background and data given as input.
addChannel(DataKeeper, DataKeeper, DataKeeper) - Method in class jhpro.stat.DataSource
Adds a channel with signal, background and data given as input.
addChannel(H1D, H1D, H1D, double, double, double, String) - Method in class jhpro.stat.DataSource
Adds a channel with signal, background and data given as input.
addChannel(P1D, P1D, P1D, double, double, double, String) - Method in class jhpro.stat.DataSource
Adds a channel with signal, background and data given as input.
addChromosome(Chromosome) - Method in class org.apache.commons.math.genetics.ListPopulation
Add the given chromosome to the population.
addChromosome(Chromosome) - Method in interface org.apache.commons.math.genetics.Population
Add the given chromosome to the population.
addComp(Component) - Method in class jhplot.GHPanel
Add a component to the main panel
addConstraint(int, int, double) - Method in class flanagan.analysis.Regression
 
addConstraint(int[], int[], int, double) - Method in class flanagan.analysis.Regression
 
addConstraint(int[], double[], int, double) - Method in class flanagan.analysis.Regression
 
addConstraint(int, int, double) - Method in class flanagan.math.Maximisation
 
addConstraint(int[], int[], int, double) - Method in class flanagan.math.Maximisation
 
addConstraint(int[], double[], int, double) - Method in class flanagan.math.Maximisation
 
addConstraint(int, int, double) - Method in class flanagan.math.Minimisation
 
addConstraint(int[], int[], int, double) - Method in class flanagan.math.Minimisation
 
addConstraint(int[], double[], int, double) - Method in class flanagan.math.Minimisation
 
addContentToBin(int[], int, double, double[], double[]) - Method in interface hep.aida.ref.dataset.binner.Binner
Add a set of entries to the existing content of the bin.
addContentToBin(int[], int, double, double[], double[]) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
 
addContentToBin(int[], int, double, double[], double[]) - Method in class hep.aida.ref.dataset.binner.EfficiencyBinner
 
addCoreListener(FunctionCoreListener) - Method in class hep.aida.ref.function.FunctionCore
 
addData(DataArray, int) - Method in class jhplot.jadraw.JaAxes
Add data to this plot.
addData(H2D, int) - Method in class jhplot.jadraw.JaAxes
Add h2d data set.
addData(ExpData) - Method in class jhpro.stat.limit.StatConfidence
Add experimental data
addData(double, double) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Adds the observation (x,y) to the regression data set.
addData(double[][]) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Adds the observations represented by the elements in data.
addEdge(String, String) - Method in class jhplot.HGraph
Add a connector between 2 vertexes
addElement(double) - Method in interface org.apache.commons.math.util.DoubleArray
Adds an element to the end of this expandable array
addElement(double) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Adds an element to the end of this expandable array.
addElementRolling(double) - Method in interface org.apache.commons.math.util.DoubleArray
Adds an element to the end of the array and removes the first element in the array.
addElementRolling(double) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Adds an element to the end of the array and removes the first element in the array.
addElements(double[]) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Adds several element to the end of this expandable array.
addEntries(double[], double[], double, double, int) - Method in class hep.aida.ref.dataset.DataStatistics
Add a set of weighted entries to this DataSetStatistics.
addEntries(double[], double[], int) - Method in class hep.aida.ref.dataset.DataStatistics
Add a set of entries to this DataSetStatistics.
addEntry(double[], double) - Method in class hep.aida.ref.dataset.DataStatistics
Add a weighted entry to this DataSetStatistics.
addEntry(double[]) - Method in class hep.aida.ref.dataset.DataStatistics
Add a new entry to this DataSetStatistics with unit weight.
addEventHandler(EventHandler, double, double, int) - Method in class org.apache.commons.math.ode.AbstractIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int) - Method in class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Add an events handler.
addEventHandler(EventHandlerWithJacobians, double, double, int) - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int) - Method in class org.apache.commons.math.ode.nonstiff.GraggBulirschStoerIntegrator
Add an event handler to the integrator.
addEventHandler(EventHandler, double, double, int) - Method in interface org.apache.commons.math.ode.ODEIntegrator
Add an event handler to the integrator.
addFace(int, Color) - Method in class jhplot.v3d.Object3d
 
addFace(int, int, int, int) - Method in class jhplot.v3d.Object3d
 
addFace(int) - Method in class jhplot.v3d.Object3d
 
addFaurePermutations() - Method in class umontreal.iro.lecuyer.hups.HaltonSequence
Permutes the digits using Faure permutations for all coordinates.
addFaurePermutations() - Method in class umontreal.iro.lecuyer.hups.HammersleyPointSet
Permutes the digits using Faure permutations for all coordinates.
addFeedForwardLayer(int) - Method in class jhplot.HNeuralNet
Construct this layer with a sigmoid threshold function.
addFirst(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
addFirst(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
addFirst(Event) - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Adds a new event at the beginning of the event list.
addFirst(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
addFirst(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
addFirst(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
addFirst(E) - Method in class umontreal.iro.lecuyer.simevents.LinkedListStat
 
addFromFactory(String, IManagedObject) - Method in class hep.aida.ref.tree.Tree
This "add" method is called from Factories (HistogramFactory, ...), and can create new folders if it is needed.
addFunc(String, String, String, String) - Method in class jhplot.HFit
Add a user 1D function in form of a string.
addFunc(String, IFunction) - Method in class jhplot.HFitter
Add a new function to catalog
addFunction(IFunction) - Method in class hep.aida.ref.function.SumOfFunctions
 
addFunctionListener(FunctionListener) - Method in class hep.aida.ref.function.AbstractIFunction
 
addFunctionListener(FunctionListener) - Method in class hep.aida.ref.function.BaseModelFunction
 
addFunctionListener(FunctionListener) - Method in interface hep.aida.ref.function.FunctionDispatcher
 
addGraph(int, int, Component) - Method in class jhplot.GHFrame
Add a graph or any component in the location given by i1 and i2.
addGraph(int, int, Component) - Method in class jhplot.GHPanel
Add a graph or any component in the location given by i1 and i2
addItem(String, String) - Method in class hep.aida.ref.Annotation
Add a key/value pair with a given visibility.
addItem(String, String, boolean) - Method in class hep.aida.ref.Annotation
 
ADDITIVE_MODE - Static variable in class org.apache.commons.math.util.ResizableDoubleArray
additive expansion mode
addKey(DataArray, int, int) - Method in class jhplot.HPlotJa
 
addLast(E) - Method in class umontreal.iro.lecuyer.simevents.LinkedListStat
 
addLegend(int, String) - Method in class jhplot.SPlot
Add a legend (displayed at the upper right) for the specified data set with the specified string.
addLegends() - Method in class flanagan.analysis.Regression
 
addListener(AIDAListener) - Method in class hep.aida.ref.event.AIDAObservable
 
addListener(AIDAListener) - Method in interface hep.aida.ref.event.IsObservable
 
addObject(Object3d) - Method in class jhplot.v3d.Model3d
 
addObservationListener(ObservationListener) - Method in class umontreal.iro.lecuyer.stat.StatProbe
Adds the observation listener l to the list of observers of this statistical probe.
addObservedPoint(double, double) - Method in class org.apache.commons.math.optimization.fitting.CurveFitter
Add an observed (x,y) point to the sample with unit weight.
addObservedPoint(double, double, double) - Method in class org.apache.commons.math.optimization.fitting.CurveFitter
Add an observed weighted (x,y) point to the sample.
addObservedPoint(WeightedObservedPoint) - Method in class org.apache.commons.math.optimization.fitting.CurveFitter
Add an observed weighted (x,y) point to the sample.
addObservedPoint(double, double) - Method in class org.apache.commons.math.optimization.fitting.GaussianFitter
Adds point (x, y) to list of observed points with a weight of 1.0.
addObservedPoint(double, double, double) - Method in class org.apache.commons.math.optimization.fitting.GaussianFitter
Adds point (x, y) to list of observed points with a weight of weight.
addObservedPoint(double, double, double) - Method in class org.apache.commons.math.optimization.fitting.HarmonicFitter
Add an observed weighted (x,y) point to the sample.
addObservedPoint(double, double, double) - Method in class org.apache.commons.math.optimization.fitting.PolynomialFitter
Add an observed weighted (x,y) point to the sample.
addObserver(Observer) - Method in class hep.aida.ref.event.ObserverAdapter
 
addPoint() - Method in class hep.aida.ref.histogram.DataPointSet
 
addPoint(IDataPoint) - Method in class hep.aida.ref.histogram.DataPointSet
 
addPoint(int, double, double, boolean) - Method in class jhplot.SPlot
In the specified data set, add the specified x, y point to the plot.
addPoint(double, double) - Method in class jhplot.stat.LinReg
Add a point to the data and redo the regression
addPoint(T) - Method in class org.apache.commons.math.stat.clustering.Cluster
Add a point to this cluster.
addPointErr(int, double, double, double, double, boolean) - Method in class jhplot.SPlot
In the specified data set, add the specified x, y point to the plot with error bars.
addRandomShift(int, int, RandomStream) - Method in class umontreal.iro.lecuyer.hups.ContainerPointSet
Calls addRandomShift(d1, d2, stream) of the contained point set.
addRandomShift(RandomStream) - Method in class umontreal.iro.lecuyer.hups.ContainerPointSet
Calls addRandomShift(stream) of the contained point set.
addRandomShift(int, int, RandomStream) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet
Adds a random shift to all the points of the point set, using stream stream to generate the random numbers, for coordinates d1 to d2 - 1.
addRandomShift(int, int, RandomStream) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2
Adds a random digital shift in base 2 to all the points of the point set, using stream stream to generate the random numbers, for coordinates d1 to d2 - 1.
addRandomShift(int, int, RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Adds a random digital shift to all the points of the point set, using stream stream to generate the random numbers.
addRandomShift(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Same as addRandomShift(0, dim, stream), where dim is the dimension of the digital net.
addRandomShift(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
addRandomShift(int, int, RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
addRandomShift(int, int, RandomStream) - Method in class umontreal.iro.lecuyer.hups.PointSet
This method does nothing for this generic class.
addRandomShift(RandomStream) - Method in class umontreal.iro.lecuyer.hups.PointSet
This method does nothing for this generic class.
addRandomShift(int, int) - Method in class umontreal.iro.lecuyer.hups.PointSet
Deprecated. 
addRandomShift() - Method in class umontreal.iro.lecuyer.hups.PointSet
Deprecated. 
addRandomShift(int, int, RandomStream) - Method in class umontreal.iro.lecuyer.hups.RandShiftedPointSet
Changes the stream used for the random shifts to stream, then refreshes the shift for coordinates d1 to d2-1.
addRandomShift(RandomStream) - Method in class umontreal.iro.lecuyer.hups.RandShiftedPointSet
Changes the stream used for the random shifts to stream, then refreshes all coordinates of the random shift, up to its current dimension.
addRandomShift(int, int) - Method in class umontreal.iro.lecuyer.hups.RandShiftedPointSet
Deprecated. 
addRandomShift() - Method in class umontreal.iro.lecuyer.hups.RandShiftedPointSet
Deprecated. 
addRandomShift(int, int, RandomStream) - Method in class umontreal.iro.lecuyer.hups.Rank1Lattice
Adds a random shift to all the points of the point set, using stream stream to generate the random numbers.
addRow() - Method in class hep.aida.ref.tuple.AbstractTuple
 
addRow() - Method in class hep.aida.ref.tuple.ReadOnlyAbstractTuple
 
addRow() - Method in class hep.aida.ref.tuple.Tuple
 
addRow() - Method in class hep.aida.ref.tuple.TupleColumn
 
addRow() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
addRow() - Method in class jhplot.SPsheet
Adds row to end of table
addSeries(Comparable, double[], int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Adds a series to the dataset, using the specified number of bins.
addSeries(Comparable, double[], int, int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Adds a series to the dataset, using the specified number of bins.
addSeries(Comparable, double[], int, double, double) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Adds a series to the dataset.
addSeries(Comparable, double[], int, int, double, double) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Adds a series to the dataset.
addSeries(Comparable, double[], HistogramBin[]) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Adds a series to the dataset.
addSeries(Comparable, double[], int, HistogramBin[]) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Adds a series to the dataset.
addStatBox(int, int) - Method in class jhplot.HPlotJa
 
addStepHandler(StepHandler) - Method in class org.apache.commons.math.ode.AbstractIntegrator
Add a step handler to this integrator.
addStepHandler(StepHandlerWithJacobians) - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Add a step handler to this integrator.
addStepHandler(StepHandler) - Method in class org.apache.commons.math.ode.nonstiff.GraggBulirschStoerIntegrator
Add a step handler to this integrator.
addStepHandler(StepHandler) - Method in interface org.apache.commons.math.ode.ODEIntegrator
Add a step handler to this integrator.
addToBack(JaObject) - Method in class jhplot.HPlotJa
Add an object to background.
addToEntry(int, int, T) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Change an entry in the specified row and column.
addToEntry(int, int, T) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Change an entry in the specified row and column.
addToEntry(int, int, T) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Change an entry in the specified row and column.
addToEntry(int, int, T) - Method in interface org.apache.commons.math.linear.FieldMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in interface org.apache.commons.math.linear.RealMatrix
Change an entry in the specified row and column.
addToEntry(int, int, double) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Change an entry in the specified row and column.
addToEntry(int, int, T) - Method in class org.apache.commons.math.linear.SparseFieldMatrix
Change an entry in the specified row and column.
addToFront(JaObject) - Method in class jhplot.HPlotJa
Add an object to foreground.
addValue(double) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Adds the value to the dataset.
addValue(double[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Add an n-tuple to the data
addValue(double) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Add a value to the data
addValue(double) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Adds the value to the dataset.
addValue(double[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Add an n-tuple to the data
addValue(double) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Add a value to the data
addValue(Object) - Method in class org.apache.commons.math.stat.Frequency
Deprecated. use Frequency.addValue(Comparable) instead
addValue(Comparable<?>) - Method in class org.apache.commons.math.stat.Frequency
Adds 1 to the frequency count for v.
addValue(int) - Method in class org.apache.commons.math.stat.Frequency
Adds 1 to the frequency count for v.
addValue(Integer) - Method in class org.apache.commons.math.stat.Frequency
Deprecated. to be removed in math 3.0
addValue(long) - Method in class org.apache.commons.math.stat.Frequency
Adds 1 to the frequency count for v.
addValue(char) - Method in class org.apache.commons.math.stat.Frequency
Adds 1 to the frequency count for v.
addVertex(String) - Method in class jhplot.HGraph
Add a new vertex
addVertex(Vector3d) - Method in class jhplot.v3d.Object3d
 
addVertex(float, float, float) - Method in class jhplot.v3d.Object3d
 
addXTick(String, double) - Method in class jhplot.SPlot
Specify a tick mark for the X axis.
addYTick(String, double) - Method in class jhplot.SPlot
Specify a tick mark for the Y axis.
advance() - Method in class org.apache.commons.math.util.OpenIntToDoubleHashMap.Iterator
Advance iterator one step further.
advance() - Method in class org.apache.commons.math.util.OpenIntToFieldHashMap.Iterator
Advance iterator one step further.
advanceState(int, int) - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated. Advances the state of this stream by k values, without modifying the states of other streams (as in setSeed), nor the values of Bg and Ig associated with this stream.
adventSunday() - Method in class flanagan.math.TimeAndDate
 
adventSunday(int) - Method in class flanagan.math.TimeAndDate
 
aexsec(double) - Static method in class flanagan.math.Fmath
 
afterEachStep() - Method in class umontreal.iro.lecuyer.simevents.Continuous
This method is executed after each integration step for this Continuous variable.
aggregate(DoubleMatrix2D, BinFunction1D[], DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Applies the given aggregation functions to each column and stores the results in a the result matrix.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(DoubleMatrix1D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(DoubleMatrix2D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(DoubleMatrix3D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(ObjectMatrix1D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(ObjectMatrix2D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(ObjectMatrix3D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DComplexDComplexDComplexFunction, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(DComplexMatrix1D, DComplexDComplexDComplexFunction, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DComplexDComplexDComplexFunction, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(DComplexMatrix2D, DComplexDComplexDComplexFunction, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DComplexDComplexDComplexFunction, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(DComplexMatrix3D, DComplexDComplexDComplexFunction, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DComplexDComplexDComplexFunction, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
aggregate(DComplexMatrix2D, DComplexDComplexDComplexFunction, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
aggregate(DComplexDComplexDComplexFunction, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
aggregate(DComplexMatrix1D, DComplexDComplexDComplexFunction, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
aggregate(DComplexDComplexDComplexFunction, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
aggregate(DComplexMatrix2D, DComplexDComplexDComplexFunction, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
aggregate(DComplexDComplexDComplexFunction, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
aggregate(DComplexMatrix3D, DComplexDComplexDComplexFunction, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
aggregate(DoubleMatrix2D, DoubleBinFunction1D[], DoubleMatrix2D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Applies the given aggregation functions to each column and stores the results in a the result matrix.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction, IntArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(DoubleMatrix1D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction, DoubleProcedure) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Applies a function to each cell that satisfies a condition and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(DoubleMatrix2D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction, DoubleProcedure) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Applies a function to each cell that satisfies a condition and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(DoubleMatrix3D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
aggregate(DoubleDoubleFunction, DoubleFunction, DoubleProcedure) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
aggregate(DoubleDoubleFunction, DoubleFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
aggregate(DoubleMatrix2D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
aggregate(DoubleDoubleFunction, DoubleFunction, IntArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
aggregate(DoubleMatrix1D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
aggregate(DoubleDoubleFunction, DoubleFunction, DoubleProcedure) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
aggregate(DoubleDoubleFunction, DoubleFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
aggregate(DoubleMatrix2D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
aggregate(DoubleDoubleFunction, DoubleFunction, DoubleProcedure) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
aggregate(DoubleDoubleFunction, DoubleFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
aggregate(DoubleMatrix3D, DoubleDoubleFunction, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
aggregate(FComplexFComplexFComplexFunction, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(FComplexMatrix1D, FComplexFComplexFComplexFunction, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(FComplexFComplexFComplexFunction, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(FComplexMatrix2D, FComplexFComplexFComplexFunction, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(FComplexFComplexFComplexFunction, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(FComplexMatrix3D, FComplexFComplexFComplexFunction, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(FComplexFComplexFComplexFunction, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
aggregate(FComplexMatrix2D, FComplexFComplexFComplexFunction, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
aggregate(FComplexFComplexFComplexFunction, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
aggregate(FComplexMatrix1D, FComplexFComplexFComplexFunction, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
aggregate(FComplexFComplexFComplexFunction, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
aggregate(FComplexMatrix2D, FComplexFComplexFComplexFunction, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
aggregate(FComplexFComplexFComplexFunction, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
aggregate(FComplexMatrix3D, FComplexFComplexFComplexFunction, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
aggregate(FloatMatrix2D, FloatBinFunction1D[], FloatMatrix2D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Applies the given aggregation functions to each column and stores the results in a the result matrix.
aggregate(FloatFloatFunction, FloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(FloatFloatFunction, FloatFunction, IntArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(FloatMatrix1D, FloatFloatFunction, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(FloatFloatFunction, FloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(FloatFloatFunction, FloatFunction, FloatProcedure) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Applies a function to each cell that satisfies a condition and aggregates the results.
aggregate(FloatFloatFunction, FloatFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(FloatMatrix2D, FloatFloatFunction, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(FloatFloatFunction, FloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(FloatFloatFunction, FloatFunction, FloatProcedure) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Applies a function to each cell that satisfies a condition and aggregates the results.
aggregate(FloatFloatFunction, FloatFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(FloatMatrix3D, FloatFloatFunction, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(FloatFloatFunction, FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
aggregate(FloatFloatFunction, FloatFunction, FloatProcedure) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
aggregate(FloatFloatFunction, FloatFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
aggregate(FloatMatrix2D, FloatFloatFunction, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
aggregate(FloatFloatFunction, FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
aggregate(FloatFloatFunction, FloatFunction, IntArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
aggregate(FloatMatrix1D, FloatFloatFunction, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
aggregate(FloatFloatFunction, FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
aggregate(FloatFloatFunction, FloatFunction, FloatProcedure) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
aggregate(FloatFloatFunction, FloatFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
aggregate(FloatMatrix2D, FloatFloatFunction, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
aggregate(FloatFloatFunction, FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
aggregate(FloatFloatFunction, FloatFunction, FloatProcedure) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
aggregate(FloatFloatFunction, FloatFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
aggregate(FloatMatrix3D, FloatFloatFunction, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
aggregate(IntIntFunction, IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
aggregate(IntIntFunction, IntFunction, IntProcedure) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
aggregate(IntIntFunction, IntFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
aggregate(IntMatrix2D, IntIntFunction, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
aggregate(IntIntFunction, IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
aggregate(IntIntFunction, IntFunction, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
aggregate(IntMatrix1D, IntIntFunction, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
aggregate(IntIntFunction, IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
aggregate(IntIntFunction, IntFunction, IntProcedure) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
aggregate(IntIntFunction, IntFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
aggregate(IntMatrix2D, IntIntFunction, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
aggregate(IntIntFunction, IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
aggregate(IntIntFunction, IntFunction, IntProcedure) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
aggregate(IntIntFunction, IntFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
aggregate(IntMatrix3D, IntIntFunction, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
aggregate(IntIntFunction, IntFunction) - Method in class cern.colt.matrix.tint.IntMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(IntIntFunction, IntFunction, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix1D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(IntMatrix1D, IntIntFunction, IntIntFunction) - Method in class cern.colt.matrix.tint.IntMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(IntIntFunction, IntFunction) - Method in class cern.colt.matrix.tint.IntMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(IntIntFunction, IntFunction, IntProcedure) - Method in class cern.colt.matrix.tint.IntMatrix2D
Applies a function to each cell that satisfies a condition and aggregates the results.
aggregate(IntIntFunction, IntFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix2D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(IntMatrix2D, IntIntFunction, IntIntFunction) - Method in class cern.colt.matrix.tint.IntMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(IntIntFunction, IntFunction) - Method in class cern.colt.matrix.tint.IntMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(IntIntFunction, IntFunction, IntProcedure) - Method in class cern.colt.matrix.tint.IntMatrix3D
Applies a function to each cell that satisfies a condition and aggregates the results.
aggregate(IntIntFunction, IntFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix3D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(IntMatrix3D, IntIntFunction, IntIntFunction) - Method in class cern.colt.matrix.tint.IntMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(LongLongFunction, LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
aggregate(LongLongFunction, LongFunction, LongProcedure) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
aggregate(LongLongFunction, LongFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
aggregate(LongMatrix2D, LongLongFunction, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
aggregate(LongLongFunction, LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
aggregate(LongLongFunction, LongFunction, IntArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
aggregate(LongMatrix1D, LongLongFunction, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
aggregate(LongLongFunction, LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
aggregate(LongLongFunction, LongFunction, LongProcedure) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
aggregate(LongLongFunction, LongFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
aggregate(LongMatrix2D, LongLongFunction, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
aggregate(LongLongFunction, LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
aggregate(LongLongFunction, LongFunction, LongProcedure) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
aggregate(LongLongFunction, LongFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
aggregate(LongMatrix3D, LongLongFunction, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
aggregate(LongLongFunction, LongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(LongLongFunction, LongFunction, IntArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(LongMatrix1D, LongLongFunction, LongLongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(LongLongFunction, LongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(LongLongFunction, LongFunction, LongProcedure) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Applies a function to each cell that satisfies a condition and aggregates the results.
aggregate(LongLongFunction, LongFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(LongMatrix2D, LongLongFunction, LongLongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(LongLongFunction, LongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(LongLongFunction, LongFunction, LongProcedure) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Applies a function to each cell that satisfies a condition and aggregates the results.
aggregate(LongLongFunction, LongFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(LongMatrix3D, LongLongFunction, LongLongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
aggregate(ObjectObjectFunction, ObjectFunction, ObjectProcedure) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
aggregate(ObjectObjectFunction, ObjectFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
aggregate(ObjectMatrix2D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
 
aggregate(ObjectObjectFunction, ObjectFunction, IntArrayList) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
 
aggregate(ObjectMatrix1D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
 
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
aggregate(ObjectObjectFunction, ObjectFunction, ObjectProcedure) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
aggregate(ObjectObjectFunction, ObjectFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
aggregate(ObjectMatrix2D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
aggregate(ObjectObjectFunction, ObjectFunction, ObjectProcedure) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
aggregate(ObjectObjectFunction, ObjectFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
aggregate(ObjectMatrix3D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Applies a function to each cell and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction, IntArrayList) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(ObjectMatrix1D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Applies a function to each cell and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction, ObjectProcedure) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Applies a function to each cell that satisfies a condition and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(ObjectMatrix2D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Applies a function to each cell and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction, ObjectProcedure) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Applies a function to each cell that satisfies a condition and aggregates the results.
aggregate(ObjectObjectFunction, ObjectFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Applies a function to all cells with a given indexes and aggregates the results.
aggregate(ObjectMatrix3D, ObjectObjectFunction, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Applies a function to each corresponding cell of two matrices and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class cern.hep.aida.bin.DynamicBin1D
Applies a function to each element and aggregates the results.
aggregate(DoubleDoubleFunction, DoubleFunction) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Applies a function to each element and aggregates the results.
aggregate(FloatFloatFunction, FloatFunction) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Applies a function to each element and aggregates the results.
aggregate(Collection<SummaryStatistics>) - Static method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Computes aggregate summary statistics.
AggregateSummaryStatistics - Class in org.apache.commons.math.stat.descriptive
An aggregator for SummaryStatistics from several data sets or data set partitions.
AggregateSummaryStatistics() - Constructor for class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Initializes a new AggregateSummaryStatistics with default statistics implementations.
AggregateSummaryStatistics(SummaryStatistics) - Constructor for class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Initializes a new AggregateSummaryStatistics with the specified statistics object as a prototype for contributing statistics and for the internal aggregate statistics.
AggregateSummaryStatistics(SummaryStatistics, SummaryStatistics) - Constructor for class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Initializes a new AggregateSummaryStatistics with the specified statistics object as a prototype for contributing statistics and for the internal aggregate statistics.
ahav(double) - Static method in class flanagan.math.Fmath
 
AIDAListener - Interface in hep.aida.ref.event
A interface to be implemented by those wishing to observe changes to AIDA objects.
AIDAObservable - Class in hep.aida.ref.event
A basic implementation of isObservable.
aidaPathKey - Static variable in class hep.aida.ref.Annotation
 
AidaUtils - Class in hep.aida.ref
 
AidaUtils() - Constructor for class hep.aida.ref.AidaUtils
 
Algebra - Class in cern.colt.matrix.linalg
Linear algebraic matrix operations operating on DoubleMatrix2D; concentrates most functionality of this package.
Algebra() - Constructor for class cern.colt.matrix.linalg.Algebra
Constructs a new instance with an equality tolerance given by Property.DEFAULT.tolerance().
Algebra(double) - Constructor for class cern.colt.matrix.linalg.Algebra
Constructs a new instance with the given equality tolerance.
allEntries() - Method in class cern.hep.aida.ref.Histogram1D
 
allEntries() - Method in class cern.hep.aida.ref.Histogram2D
 
allEntries() - Method in class cern.hep.aida.ref.Histogram3D
 
allEntries() - Method in class hep.aida.ref.histogram.Histogram
Get all the entries in the Histogram, i.e.
allEntries() - Method in class hep.aida.ref.histogram.Profile1D
 
allEntries() - Method in class hep.aida.ref.histogram.Profile2D
 
allEntries() - Method in interface hep.aida.tdouble.DoubleIHistogram
Number of all entries in all (both in-range and under/overflow) bins in the histogram.
allEntries() - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
allEntries() - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
allEntries() - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
allEntries() - Method in interface hep.aida.tfloat.FloatIHistogram
Number of all entries in all (both in-range and under/overflow) bins in the histogram.
allEntries() - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
allEntries() - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
allEntries() - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
allEntries() - Method in class jhplot.H1D
Get number of all entries
allEntries() - Method in class jhplot.H2D
Get number of all entries
allEntries() - Method in class jhplot.HProf1D
Get number of all entries
allEntries() - Method in class jhplot.HProf2D
Get number of all entries
allocateBlas(int, Blas) - Static method in class cern.colt.matrix.linalg.SmpBlas
Sets the public global variable SmpBlas.smpBlas to a blas using a maximum of maxThreads threads, each executing the given sequential algorithm; maxThreads is normally the number of CPUs.
alpha - Variable in class flanagan.analysis.LogNormalThreeParFunct
 
alpha_rcl2 - Static variable in class cern.clhep.PhysicalConstants
 
ampere - Static variable in class cern.clhep.Units
 
amu - Static variable in class cern.clhep.PhysicalConstants
 
amu_c2 - Static variable in class cern.clhep.PhysicalConstants
 
analF() - Method in class jhplot.HPlot
Return IAnalysisFactory associated with the plot
analF() - Method in class jhplot.HPlotJa
Return IAnalysisFactory associated with the plot
analyseSet() - Method in class jminhep.cluster.DataHolder
Analyse the data holder by calculating min and max.
analysis() - Method in class flanagan.analysis.BoxCox
 
analysis(String) - Method in class flanagan.analysis.BoxCox
 
analysis() - Method in class flanagan.analysis.Cronbach
 
analysis(String) - Method in class flanagan.analysis.Cronbach
 
analysis() - Method in class flanagan.analysis.PCA
 
analysis(String) - Method in class flanagan.analysis.PCA
 
analysis() - Method in class flanagan.analysis.RankAnalysis
 
analysis(String) - Method in class flanagan.analysis.RankAnalysis
 
AnalysisFactory - Class in hep.aida.ref
 
AnalysisFactory() - Constructor for class hep.aida.ref.AnalysisFactory
 
and(BitMatrix) - Method in class cern.colt.bitvector.BitMatrix
Performs a logical AND of the receiver with another bit matrix.
and(BitVector) - Method in class cern.colt.bitvector.BitVector
Performs a logical AND of the receiver with another bit vector (A = A & B).
and(BitMatrix) - Method in class cern.colt.matrix.tbit.BitMatrix
Performs a logical AND of the receiver with another bit matrix.
and(BitVector) - Method in class cern.colt.matrix.tbit.BitVector
Performs a logical AND of the receiver with another bit vector (A = A & B).
and - Static variable in class cern.jet.math.IntFunctions
Function that returns a & b.
and(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a & b.
and - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a & b.
and(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a & b.
and - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a & b.
and(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a & b.
and(BitMatrix) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Returns the BitMatrix resulting from the application of the and operator on the original BitMatrix and that.
and(BitVector) - Method in class umontreal.iro.lecuyer.util.BitVector
Returns a BitVector which is the result of the and operator with both the this and that BitVector's.
andersonDarling(DoubleArrayList) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Computes and returns the Anderson-Darling statistic AN2.
AndersonDarlingDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Anderson-Darling distribution (see).
AndersonDarlingDist(int) - Constructor for class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
Constructs an Anderson-Darling distribution for a sample of size n.
AndersonDarlingDistQuick - Class in umontreal.iro.lecuyer.probdist
Extends the class AndersonDarlingDist for the distribution (see).
AndersonDarlingDistQuick(int) - Constructor for class umontreal.iro.lecuyer.probdist.AndersonDarlingDistQuick
Constructs an distribution for a sample of size n.
andNot(BitMatrix) - Method in class cern.colt.bitvector.BitMatrix
Clears all of the bits in receiver whose corresponding bit is set in the other bit matrix.
andNot(BitVector) - Method in class cern.colt.bitvector.BitVector
Clears all of the bits in receiver whose corresponding bit is set in the other bitvector (A = A \ B).
andNot(BitMatrix) - Method in class cern.colt.matrix.tbit.BitMatrix
Clears all of the bits in receiver whose corresponding bit is set in the other bit matrix.
andNot(BitVector) - Method in class cern.colt.matrix.tbit.BitVector
Clears all of the bits in receiver whose corresponding bit is set in the other bitvector (A = A \ B).
angle(double, double, double, double, double, double) - Static method in class flanagan.math.Fmath
 
angle(double, double, double) - Static method in class flanagan.math.Fmath
 
angle(LParticle) - Method in class hephysics.particle.LParticle
Angle between 2 vectors in rad
angle(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Angle between 2 vectors
angle(HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Angle between 2 vectors
angle(Vector3D, Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3D
Compute the angular separation between two vectors.
angstrom - Static variable in class cern.clhep.Units
 
Animation - Class in jhplot.v3d
 
Animation() - Constructor for class jhplot.v3d.Animation
 
Annotation - Class in hep.aida.ref
 
Annotation() - Constructor for class hep.aida.ref.Annotation
Creates a new instance of Annotation.
Annotation(IAnnotation) - Constructor for class hep.aida.ref.Annotation
 
annotation() - Method in class hep.aida.ref.fitter.InternalFitFunction
 
annotation() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
annotation() - Method in class hep.aida.ref.function.AbstractIFunction
 
annotation() - Method in class hep.aida.ref.function.BaseModelFunction
 
annotation() - Method in class hep.aida.ref.function.SumOfFunctions
 
annotation() - Method in class hep.aida.ref.histogram.AbstractBaseHistogram
Get the IAnnotation associated with the histogram.
annotation() - Method in class hep.aida.ref.histogram.DataPointSet
 
annotation() - Method in class hep.aida.ref.tuple.AbstractTuple
 
annunciation() - Method in class flanagan.math.TimeAndDate
 
annunciation(int) - Method in class flanagan.math.TimeAndDate
 
anovaFValue(Collection<double[]>) - Method in interface org.apache.commons.math.stat.inference.OneWayAnova
Computes the ANOVA F-value for a collection of double[] arrays.
anovaFValue(Collection<double[]>) - Method in class org.apache.commons.math.stat.inference.OneWayAnovaImpl
Computes the ANOVA F-value for a collection of double[] arrays.
anovaPValue(Collection<double[]>) - Method in interface org.apache.commons.math.stat.inference.OneWayAnova
Computes the ANOVA P-value for a collection of double[] arrays.
anovaPValue(Collection<double[]>) - Method in class org.apache.commons.math.stat.inference.OneWayAnovaImpl
Computes the ANOVA P-value for a collection of double[] arrays.
anovaTest(Collection<double[]>, double) - Method in interface org.apache.commons.math.stat.inference.OneWayAnova
Performs an ANOVA test, evaluating the null hypothesis that there is no difference among the means of the data categories.
anovaTest(Collection<double[]>, double) - Method in class org.apache.commons.math.stat.inference.OneWayAnovaImpl
Performs an ANOVA test, evaluating the null hypothesis that there is no difference among the means of the data categories.
antilog(double) - Static method in class flanagan.math.Fmath
 
antilog(float) - Static method in class flanagan.math.Fmath
 
antilog10() - Method in class flanagan.analysis.Stat
 
antilog10() - Method in class flanagan.math.ArrayMaths
 
antilog10(double) - Static method in class flanagan.math.Fmath
 
antilog10(float) - Static method in class flanagan.math.Fmath
 
antilog2(double) - Static method in class flanagan.math.Fmath
 
antilog2(float) - Static method in class flanagan.math.Fmath
 
AntitheticPointSet - Class in umontreal.iro.lecuyer.hups
This container class provides antithetic points.
AntitheticPointSet(PointSet) - Constructor for class umontreal.iro.lecuyer.hups.AntitheticPointSet
Constructs an antithetic point set from the given point set P.
AntitheticStream - Class in umontreal.iro.lecuyer.rng
This container class allows the user to force any RandomStream to return antithetic variates.
AntitheticStream(RandomStream) - Constructor for class umontreal.iro.lecuyer.rng.AntitheticStream
Constructs a new antithetic stream, using the random numbers from the base stream stream.
AnyMatrix - Interface in org.apache.commons.math.linear
Interface defining very basic matrix operations.
append(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(ObjectMatrix1D, ObjectMatrix1D) - Method in class cern.colt.matrix.ObjectFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(DComplexMatrix1D, DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(FComplexMatrix1D, FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(IntMatrix1D, IntMatrix1D) - Method in class cern.colt.matrix.tint.IntFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(LongMatrix1D, LongMatrix1D) - Method in class cern.colt.matrix.tlong.LongFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(ObjectMatrix1D, ObjectMatrix1D) - Method in class cern.colt.matrix.tobject.ObjectFactory1D
C = A||B; Constructs a new matrix which is the concatenation of two other matrices.
append(File, String) - Static method in class jhplot.math.io.ASCIIFile
 
append(FieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector by appending a vector to this vector.
append(ArrayFieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector by appending a vector to this vector.
append(T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector by appending a T to this vector.
append(T[]) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector by appending a T array to this vector.
append(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Construct a vector by appending a vector to this vector.
append(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Construct a vector by appending a vector to this vector.
append(double) - Method in class org.apache.commons.math.linear.ArrayRealVector
Construct a vector by appending a double to this vector.
append(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Construct a vector by appending a double array to this vector.
append(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldVector
Construct a vector by appending a vector to this vector.
append(T) - Method in interface org.apache.commons.math.linear.FieldVector
Construct a vector by appending a T to this vector.
append(T[]) - Method in interface org.apache.commons.math.linear.FieldVector
Construct a vector by appending a T array to this vector.
append(OpenMapRealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Optimized method to append a OpenMapRealVector.
append(RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Construct a vector by appending a vector to this vector.
append(double) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Construct a vector by appending a double to this vector.
append(double[]) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Construct a vector by appending a double array to this vector.
append(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Construct a vector by appending a vector to this vector.
append(double) - Method in interface org.apache.commons.math.linear.RealVector
Construct a vector by appending a double to this vector.
append(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Construct a vector by appending a double array to this vector.
append(SparseFieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Construct a vector by appending a vector to this vector.
append(FieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Construct a vector by appending a vector to this vector.
append(T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Construct a vector by appending a T to this vector.
append(T[]) - Method in class org.apache.commons.math.linear.SparseFieldVector
Construct a vector by appending a T array to this vector.
append(ContinuousOutputModel) - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Append another model at the end of the instance.
append(String) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Appends str to the buffer.
append(int, String) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Uses the s static method to append str to the buffer.
append(double) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Appends x to the buffer.
append(int, double) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Uses the f static method to append x to the buffer.
append(int, int, double) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Uses the f static method to append x to the buffer.
append(int) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Appends x to the buffer.
append(int, int) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Uses the d static method to append x to the buffer.
append(long) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Appends x to the buffer.
append(int, long) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Uses the d static method to append x to the buffer.
append(int, int, int, double) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Uses the format static method with the same four arguments to append x to the buffer.
append(char) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Appends a single character to the buffer.
append(CharSequence) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
 
append(CharSequence, int, int) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
 
appendColumn(DComplexMatrix2D, DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
C = A||b; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumn(DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
C = A||b; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumn(FComplexMatrix2D, FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
C = A||b; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumn(FloatMatrix2D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
C = A||b; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumn(IntMatrix2D, IntMatrix1D) - Method in class cern.colt.matrix.tint.IntFactory2D
 
appendColumn(LongMatrix2D, LongMatrix1D) - Method in class cern.colt.matrix.tlong.LongFactory2D
 
appendColumns(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumns(ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumns(DComplexMatrix2D, DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumns(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumns(FComplexMatrix2D, FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumns(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumns(IntMatrix2D, IntMatrix2D) - Method in class cern.colt.matrix.tint.IntFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumns(LongMatrix2D, LongMatrix2D) - Method in class cern.colt.matrix.tlong.LongFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendColumns(ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
C = A||B; Constructs a new matrix which is the column-wise concatenation of two other matrices.
appendDoubleArray(File, double[], String) - Static method in class jhplot.math.io.BinaryFile
 
appendDoubleArray(OutputStream, double[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
appendFloatArray(File, float[], String) - Static method in class jhplot.math.io.BinaryFile
 
appendFloatArray(OutputStream, float[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
appendIntArray(File, int[], String) - Static method in class jhplot.math.io.BinaryFile
 
appendIntArray(OutputStream, int[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
appendRow(DComplexMatrix2D, DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
C = A||b; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRow(DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
C = A||b; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRow(FComplexMatrix2D, FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
C = A||b; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRow(FloatMatrix2D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
C = A||b; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRow(IntMatrix2D, IntMatrix1D) - Method in class cern.colt.matrix.tint.IntFactory2D
 
appendRow(LongMatrix2D, LongMatrix1D) - Method in class cern.colt.matrix.tlong.LongFactory2D
 
appendRows(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRows(ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRows(DComplexMatrix2D, DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRows(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRows(FComplexMatrix2D, FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRows(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRows(IntMatrix2D, IntMatrix2D) - Method in class cern.colt.matrix.tint.IntFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRows(LongMatrix2D, LongMatrix2D) - Method in class cern.colt.matrix.tlong.LongFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
appendRows(ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
C = A||B; Constructs a new matrix which is the row-wise concatenation of two other matrices.
apply(boolean) - Method in interface cern.colt.function.BooleanProcedure
Applies a procedure to an argument.
apply(byte) - Method in interface cern.colt.function.ByteProcedure
Applies a procedure to an argument.
apply(char) - Method in interface cern.colt.function.CharProcedure
Applies a procedure to an argument.
apply(double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double) - Method in interface cern.colt.function.Double27Function
Applies a function to 27 arguments.
apply(double, double, double, double, double) - Method in interface cern.colt.function.Double5Function
Applies a function to two arguments.
apply(double, double, double, double, double, double, double, double, double) - Method in interface cern.colt.function.Double9Function
Applies a function to nine arguments.
apply(double, double) - Method in interface cern.colt.function.DoubleDoubleFunction
Applies a function to two arguments.
apply(double, double) - Method in interface cern.colt.function.DoubleDoubleProcedure
Applies a procedure to two arguments.
apply(double) - Method in interface cern.colt.function.DoubleFunction
Applies a function to an argument.
apply(double, int) - Method in interface cern.colt.function.DoubleIntProcedure
Applies a procedure to two arguments.
apply(double) - Method in interface cern.colt.function.DoubleProcedure
Applies a procedure to an argument.
apply(float) - Method in interface cern.colt.function.FloatProcedure
Applies a procedure to an argument.
apply(int, double) - Method in interface cern.colt.function.IntDoubleFunction
Applies a function to two arguments.
apply(int, double) - Method in interface cern.colt.function.IntDoubleProcedure
Applies a procedure to two arguments.
apply(int) - Method in interface cern.colt.function.IntFunction
Applies a function to an argument.
apply(int, int, double) - Method in interface cern.colt.function.IntIntDoubleFunction
Applies a function to three arguments.
apply(int, int, double) - Method in interface cern.colt.function.IntIntDoubleProcedure
Applies a procedure to two arguments.
apply(int, int) - Method in interface cern.colt.function.IntIntFunction
Applies a function to two arguments.
apply(int, int, int) - Method in interface cern.colt.function.IntIntIntProcedure
Applies a procedure to three arguments.
apply(int, int) - Method in interface cern.colt.function.IntIntProcedure
Applies a procedure to two arguments.
apply(int, Object) - Method in interface cern.colt.function.IntObjectProcedure
Applies a procedure to two arguments.
apply(int) - Method in interface cern.colt.function.IntProcedure
Applies a procedure to an argument.
apply(long, Object) - Method in interface cern.colt.function.LongObjectProcedure
Applies a procedure to two arguments.
apply(long) - Method in interface cern.colt.function.LongProcedure
Applies a procedure to an argument.
apply(Object) - Method in interface cern.colt.function.ObjectFunction
Applies a function to an argument.
apply(Object, Object) - Method in interface cern.colt.function.ObjectObjectFunction
Applies a function to two arguments.
apply(Object) - Method in interface cern.colt.function.ObjectProcedure
Applies a procedure to an argument.
apply(short) - Method in interface cern.colt.function.ShortProcedure
Applies a procedure to an argument.
apply(boolean) - Method in interface cern.colt.function.tboolean.BooleanProcedure
Applies a procedure to an argument.
apply(byte) - Method in interface cern.colt.function.tbyte.ByteFunction
Applies a function to an argument.
apply(byte) - Method in interface cern.colt.function.tbyte.ByteProcedure
Applies a procedure to an argument.
apply(char) - Method in interface cern.colt.function.tchar.CharProcedure
Applies a procedure to an argument.
apply(double[], double[]) - Method in interface cern.colt.function.tdcomplex.DComplexDComplexDComplexFunction
Applies a function to two complex arguments.
apply(double[]) - Method in interface cern.colt.function.tdcomplex.DComplexDComplexFunction
Applies a function to a complex argument.
apply(double, double) - Method in interface cern.colt.function.tdcomplex.DComplexDComplexFunction
Applies a function to a complex argument.
apply(double[], double[]) - Method in interface cern.colt.function.tdcomplex.DComplexDComplexProcedure
 
apply(double[], double[]) - Method in interface cern.colt.function.tdcomplex.DComplexDComplexRealFunction
 
apply(double[], double[], double) - Method in interface cern.colt.function.tdcomplex.DComplexDComplexRealProcedure
 
apply(double[], double[], double) - Method in interface cern.colt.function.tdcomplex.DComplexDComplexRealRealFunction
 
apply(double[]) - Method in interface cern.colt.function.tdcomplex.DComplexProcedure
Applies a procedure to an argument.
apply(double[], double) - Method in interface cern.colt.function.tdcomplex.DComplexRealDComplexFunction
 
apply(double[]) - Method in interface cern.colt.function.tdcomplex.DComplexRealFunction
 
apply(int, int, double[]) - Method in interface cern.colt.function.tdcomplex.IntIntDComplexFunction
Applies a function to three arguments.
apply(double, double[]) - Method in interface cern.colt.function.tdcomplex.RealDComplexDComplexFunction
 
apply(double) - Method in interface cern.colt.function.tdcomplex.RealDComplexFunction
 
apply(double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double, double) - Method in interface cern.colt.function.tdouble.Double27Function
Applies a function to 27 arguments.
apply(double, double, double, double, double) - Method in interface cern.colt.function.tdouble.Double5Function
Applies a function to two arguments.
apply(double, double, double, double, double, double, double, double, double) - Method in interface cern.colt.function.tdouble.Double9Function
Applies a function to nine arguments.
apply(double, double) - Method in interface cern.colt.function.tdouble.DoubleDoubleFunction
Applies a function to two arguments.
apply(double, double) - Method in interface cern.colt.function.tdouble.DoubleDoubleProcedure
Applies a procedure to two arguments.
apply(double) - Method in interface cern.colt.function.tdouble.DoubleFunction
Applies a function to an argument.
apply(double, int) - Method in interface cern.colt.function.tdouble.DoubleIntProcedure
Applies a procedure to two arguments.
apply(double, long) - Method in interface cern.colt.function.tdouble.DoubleLongProcedure
Applies a procedure to two arguments.
apply(double) - Method in interface cern.colt.function.tdouble.DoubleProcedure
Applies a procedure to an argument.
apply(int, double) - Method in interface cern.colt.function.tdouble.IntDoubleFunction
Applies a function to two arguments.
apply(int, double) - Method in interface cern.colt.function.tdouble.IntDoubleProcedure
Applies a procedure to two arguments.
apply(int, int, double) - Method in interface cern.colt.function.tdouble.IntIntDoubleFunction
Applies a function to three arguments.
apply(int, int, double) - Method in interface cern.colt.function.tdouble.IntIntDoubleProcedure
Applies a procedure to two arguments.
apply(long, double) - Method in interface cern.colt.function.tdouble.LongDoubleProcedure
Applies a procedure to two arguments.
apply(float[], float[]) - Method in interface cern.colt.function.tfcomplex.FComplexFComplexFComplexFunction
Applies a function to two complex arguments.
apply(float[]) - Method in interface cern.colt.function.tfcomplex.FComplexFComplexFunction
Applies a function to a complex argument.
apply(float, float) - Method in interface cern.colt.function.tfcomplex.FComplexFComplexFunction
Applies a function to a complex argument.
apply(float[], float[]) - Method in interface cern.colt.function.tfcomplex.FComplexFComplexProcedure
 
apply(float[], float[]) - Method in interface cern.colt.function.tfcomplex.FComplexFComplexRealFunction
 
apply(float[], float[], float) - Method in interface cern.colt.function.tfcomplex.FComplexFComplexRealProcedure
 
apply(float[], float[], float) - Method in interface cern.colt.function.tfcomplex.FComplexFComplexRealRealFunction
 
apply(float[]) - Method in interface cern.colt.function.tfcomplex.FComplexProcedure
Applies a procedure to an argument.
apply(float[], float) - Method in interface cern.colt.function.tfcomplex.FComplexRealFComplexFunction
 
apply(float[]) - Method in interface cern.colt.function.tfcomplex.FComplexRealFunction
 
apply(int, int, float[]) - Method in interface cern.colt.function.tfcomplex.IntIntFComplexFunction
Applies a function to three arguments.
apply(float, float[]) - Method in interface cern.colt.function.tfcomplex.RealFComplexFComplexFunction
 
apply(float) - Method in interface cern.colt.function.tfcomplex.RealFComplexFunction
 
apply(float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float, float) - Method in interface cern.colt.function.tfloat.Float27Function
Applies a function to 27 arguments.
apply(float, float, float, float, float, float, float, float, float) - Method in interface cern.colt.function.tfloat.Float9Function
Applies a function to nine arguments.
apply(float, float) - Method in interface cern.colt.function.tfloat.FloatFloatFunction
Applies a function to two arguments.
apply(float, float) - Method in interface cern.colt.function.tfloat.FloatFloatProcedure
Applies a procedure to two arguments.
apply(float) - Method in interface cern.colt.function.tfloat.FloatFunction
Applies a function to an argument.
apply(float, int) - Method in interface cern.colt.function.tfloat.FloatIntProcedure
Applies a procedure to two arguments.
apply(float, long) - Method in interface cern.colt.function.tfloat.FloatLongProcedure
Applies a procedure to two arguments.
apply(float) - Method in interface cern.colt.function.tfloat.FloatProcedure
Applies a procedure to an argument.
apply(int, float) - Method in interface cern.colt.function.tfloat.IntFloatProcedure
Applies a procedure to two arguments.
apply(int, int, float) - Method in interface cern.colt.function.tfloat.IntIntFloatFunction
Applies a function to three arguments.
apply(long, float) - Method in interface cern.colt.function.tfloat.LongFloatProcedure
Applies a procedure to two arguments.
apply(int) - Method in interface cern.colt.function.tint.IntFunction
Applies a function to an argument.
apply(int, int) - Method in interface cern.colt.function.tint.IntIntFunction
Applies a function to two arguments.
apply(int, int, int) - Method in interface cern.colt.function.tint.IntIntIntFunction
Applies a function to three arguments.
apply(int, int, int) - Method in interface cern.colt.function.tint.IntIntIntProcedure
Applies a procedure to three arguments.
apply(int, int) - Method in interface cern.colt.function.tint.IntIntProcedure
Applies a procedure to two arguments.
apply(int) - Method in interface cern.colt.function.tint.IntProcedure
Applies a procedure to an argument.
apply(int, int, long) - Method in interface cern.colt.function.tlong.IntIntLongFunction
Applies a function to three arguments.
apply(int, long) - Method in interface cern.colt.function.tlong.IntLongProcedure
Applies a procedure to two arguments.
apply(long) - Method in interface cern.colt.function.tlong.LongFunction
Applies a function to an argument.
apply(long, int) - Method in interface cern.colt.function.tlong.LongIntProcedure
Applies a procedure to two arguments.
apply(long, long) - Method in interface cern.colt.function.tlong.LongLongFunction
Applies a function to two arguments.
apply(long, long, long) - Method in interface cern.colt.function.tlong.LongLongLongProcedure
Applies a procedure to three arguments.
apply(long, long) - Method in interface cern.colt.function.tlong.LongLongProcedure
Applies a procedure to two arguments.
apply(long) - Method in interface cern.colt.function.tlong.LongProcedure
Applies a procedure to an argument.
apply(int, int, Object) - Method in interface cern.colt.function.tobject.IntIntObjectFunction
Applies a function to three arguments.
apply(int, Object) - Method in interface cern.colt.function.tobject.IntObjectProcedure
Applies a procedure to two arguments.
apply(long, Object) - Method in interface cern.colt.function.tobject.LongObjectProcedure
Applies a procedure to two arguments.
apply(Object) - Method in interface cern.colt.function.tobject.ObjectFunction
Applies a function to an argument.
apply(Object, Object) - Method in interface cern.colt.function.tobject.ObjectObjectFunction
Applies a function to two arguments.
apply(Object) - Method in interface cern.colt.function.tobject.ObjectProcedure
Applies a procedure to an argument.
apply(short) - Method in interface cern.colt.function.tshort.ShortProcedure
Applies a procedure to an argument.
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.doublealgo.Statistic.VectorVectorFunction
Applies a function to two argument vectors.
apply(DoubleMatrix1D) - Method in interface cern.colt.matrix.DoubleMatrix1DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix2D) - Method in interface cern.colt.matrix.DoubleMatrix2DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix3D) - Method in interface cern.colt.matrix.DoubleMatrix3DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Matrix2DMatrix2DFunction
Applies a function to two arguments.
apply(ObjectMatrix1D) - Method in interface cern.colt.matrix.ObjectMatrix1DProcedure
Applies a procedure to an argument.
apply(ObjectMatrix2D) - Method in interface cern.colt.matrix.ObjectMatrix2DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix3D) - Method in interface cern.colt.matrix.ObjectMatrix3DProcedure
Applies a procedure to an argument.
apply(ObjectMatrix3D) - Method in interface cern.colt.matrix.ObjectMatrix3DProcedure
Applies a procedure to an argument.
apply(DComplexMatrix1D) - Method in interface cern.colt.matrix.tdcomplex.DComplexMatrix1DProcedure
Applies a procedure to an argument.
apply(DComplexMatrix2D) - Method in interface cern.colt.matrix.tdcomplex.DComplexMatrix2DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleMatrix2DMatrix2DFunction
Applies a function to two arguments.
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleStatistic.VectorVectorFunction
Applies a function to two argument vectors.
apply(DoubleMatrix2D, int, int, int) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleGivensRotation
Applies the Givens rotation to two elements in a matrix column
apply(DoubleMatrix1D, int, int) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleGivensRotation
Applies the Givens rotation to two elements of a vector
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleAMG
 
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleDiagonal
 
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleICC
 
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleIdentity
 
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleILU
 
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleILUT
 
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.solver.preconditioner.DoublePreconditioner
Solves the approximate problem with the given right hand side.
apply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleSSOR
 
apply(DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.DoubleMatrix1DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix2D) - Method in interface cern.colt.matrix.tdouble.DoubleMatrix2DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix3D) - Method in interface cern.colt.matrix.tdouble.DoubleMatrix3DProcedure
Applies a procedure to an argument.
apply(FComplexMatrix1D) - Method in interface cern.colt.matrix.tfcomplex.FComplexMatrix1DProcedure
Applies a procedure to an argument.
apply(FComplexMatrix2D) - Method in interface cern.colt.matrix.tfcomplex.FComplexMatrix2DProcedure
Applies a procedure to an argument.
apply(FloatMatrix2D, FloatMatrix2D) - Method in interface cern.colt.matrix.tfloat.algo.FloatMatrix2DMatrix2DFunction
Applies a function to two arguments.
apply(FloatMatrix1D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatStatistic.VectorVectorFunction
Applies a function to two argument vectors.
apply(FloatMatrix2D, int, int, int) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatGivensRotation
Applies the Givens rotation to two elements in a matrix column
apply(FloatMatrix1D, int, int) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatGivensRotation
Applies the Givens rotation to two elements of a vector
apply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatAMG
 
apply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatDiagonal
 
apply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatICC
 
apply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatIdentity
 
apply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatILU
 
apply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatILUT
 
apply(FloatMatrix1D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatPreconditioner
Solves the approximate problem with the given right hand side.
apply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatSSOR
 
apply(FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.FloatMatrix1DProcedure
Applies a procedure to an argument.
apply(FloatMatrix2D) - Method in interface cern.colt.matrix.tfloat.FloatMatrix2DProcedure
Applies a procedure to an argument.
apply(FloatMatrix3D) - Method in interface cern.colt.matrix.tfloat.FloatMatrix3DProcedure
Applies a procedure to an argument.
apply(IntMatrix1D) - Method in interface cern.colt.matrix.tint.IntMatrix1DProcedure
Applies a procedure to an argument.
apply(IntMatrix2D) - Method in interface cern.colt.matrix.tint.IntMatrix2DProcedure
Applies a procedure to an argument.
apply(IntMatrix3D) - Method in interface cern.colt.matrix.tint.IntMatrix3DProcedure
Applies a procedure to an argument.
apply(LongMatrix1D) - Method in interface cern.colt.matrix.tlong.LongMatrix1DProcedure
Applies a procedure to an argument.
apply(LongMatrix2D) - Method in interface cern.colt.matrix.tlong.LongMatrix2DProcedure
Applies a procedure to an argument.
apply(LongMatrix3D) - Method in interface cern.colt.matrix.tlong.LongMatrix3DProcedure
Applies a procedure to an argument.
apply(ObjectMatrix1D) - Method in interface cern.colt.matrix.tobject.ObjectMatrix1DProcedure
Applies a procedure to an argument.
apply(ObjectMatrix2D) - Method in interface cern.colt.matrix.tobject.ObjectMatrix2DProcedure
Applies a procedure to an argument.
apply(DoubleMatrix3D) - Method in interface cern.colt.matrix.tobject.ObjectMatrix3DProcedure
Applies a procedure to an argument.
apply(ObjectMatrix3D) - Method in interface cern.colt.matrix.tobject.ObjectMatrix3DProcedure
Applies a procedure to an argument.
apply(DynamicBin1D, DynamicBin1D) - Method in interface cern.hep.aida.bin.BinBinFunction1D
Applies a function to two bin arguments.
apply(DynamicBin1D) - Method in interface cern.hep.aida.bin.BinFunction1D
Applies a function to one bin argument.
apply(double) - Method in class cern.jet.math.Mult
Returns the result of the function evaluation.
apply(double, double) - Method in class cern.jet.math.PlusMult
Returns the result of the function evaluation.
apply(double[]) - Method in class cern.jet.math.tdcomplex.DComplexMult
Returns the result of the function evaluation.
apply(double, double) - Method in class cern.jet.math.tdcomplex.DComplexMult
Returns the result of the function evaluation.
apply(double[], double[]) - Method in class cern.jet.math.tdcomplex.DComplexPlusMultFirst
Returns the result of the function evaluation.
apply(double[], double[]) - Method in class cern.jet.math.tdcomplex.DComplexPlusMultSecond
Returns the result of the function evaluation.
apply(double) - Method in class cern.jet.math.tdouble.DoubleMult
Returns the result of the function evaluation.
apply(double, double) - Method in class cern.jet.math.tdouble.DoublePlusMultFirst
Returns the result of the function evaluation.
apply(double, double) - Method in class cern.jet.math.tdouble.DoublePlusMultSecond
Returns the result of the function evaluation.
apply(float[]) - Method in class cern.jet.math.tfcomplex.FComplexMult
Returns the result of the function evaluation.
apply(float, float) - Method in class cern.jet.math.tfcomplex.FComplexMult
Returns the result of the function evaluation.
apply(float[], float[]) - Method in class cern.jet.math.tfcomplex.FComplexPlusMultFirst
Returns the result of the function evaluation.
apply(float[], float[]) - Method in class cern.jet.math.tfcomplex.FComplexPlusMultSecond
Returns the result of the function evaluation.
apply(float) - Method in class cern.jet.math.tfloat.FloatMult
Returns the result of the function evaluation.
apply(float, float) - Method in class cern.jet.math.tfloat.FloatPlusMultFirst
Returns the result of the function evaluation.
apply(float, float) - Method in class cern.jet.math.tfloat.FloatPlusMultSecond
Returns the result of the function evaluation.
apply(int) - Method in class cern.jet.math.tint.IntMult
Returns the result of the function evaluation.
apply(int, int) - Method in class cern.jet.math.tint.IntPlusMultFirst
Returns the result of the function evaluation.
apply(int, int) - Method in class cern.jet.math.tint.IntPlusMultSecond
Returns the result of the function evaluation.
apply(long) - Method in class cern.jet.math.tlong.LongMult
Returns the result of the function evaluation.
apply(long, long) - Method in class cern.jet.math.tlong.LongPlusMultFirst
Returns the result of the function evaluation.
apply(long, long) - Method in class cern.jet.math.tlong.LongPlusMultSecond
Returns the result of the function evaluation.
apply(double) - Method in class cern.jet.random.AbstractDistribution
Equivalent to nextDouble().
apply(int) - Method in class cern.jet.random.AbstractDistribution
Equivalent to nextInt().
apply(double) - Method in class cern.jet.random.engine.RandomEngine
Equivalent to raw().
apply(int) - Method in class cern.jet.random.engine.RandomEngine
Equivalent to nextInt().
apply(double) - Method in class cern.jet.random.tdouble.AbstractDoubleDistribution
Equivalent to nextDouble().
apply(int) - Method in class cern.jet.random.tdouble.AbstractDoubleDistribution
Equivalent to nextInt().
apply(double) - Method in class cern.jet.random.tdouble.engine.DoubleRandomEngine
Equivalent to raw().
apply(int) - Method in class cern.jet.random.tdouble.engine.DoubleRandomEngine
Equivalent to nextInt().
apply(long) - Method in class cern.jet.random.tdouble.engine.DoubleRandomEngine
Equivalent to nextLong().
apply(float) - Method in class cern.jet.random.tfloat.AbstractFloatDistribution
Equivalent to nextFloat().
apply(int) - Method in class cern.jet.random.tfloat.AbstractFloatDistribution
Equivalent to nextInt().
apply(float) - Method in class cern.jet.random.tfloat.engine.FloatRandomEngine
Equivalent to raw().
apply(int) - Method in class cern.jet.random.tfloat.engine.FloatRandomEngine
Equivalent to nextInt().
apply(DynamicDoubleBin1D, DynamicDoubleBin1D) - Method in interface hep.aida.tdouble.bin.DoubleBinBinFunction1D
Applies a function to two bin arguments.
apply(DynamicDoubleBin1D) - Method in interface hep.aida.tdouble.bin.DoubleBinFunction1D
Applies a function to one bin argument.
apply(DynamicFloatBin1D, DynamicFloatBin1D) - Method in interface hep.aida.tfloat.bin.FloatBinBinFunction1D
Applies a function to two bin arguments.
apply(DynamicFloatBin1D) - Method in interface hep.aida.tfloat.bin.FloatBinFunction1D
Applies a function to one bin argument.
apply(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Apply the given statistic to the data associated with this set of statistics.
apply(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Apply the given statistic to the data associated with this set of statistics.
apply(RandomStream) - Method in interface umontreal.iro.lecuyer.hups.Randomization
Deprecated. Applies this randomization to the point set using stream stream.
applyInverseTo(Vector3D) - Method in class org.apache.commons.math.geometry.Rotation
Apply the inverse of the rotation to a vector.
applyInverseTo(Rotation) - Method in class org.apache.commons.math.geometry.Rotation
Apply the inverse of the instance to another rotation.
applyTo(Vector3D) - Method in class org.apache.commons.math.geometry.Rotation
Apply the rotation to a vector.
applyTo(Rotation) - Method in class org.apache.commons.math.geometry.Rotation
Apply the instance to another rotation.
ARCH - Static variable in class org.netlib.utils.JNIMethods
Stores the CPU Architecture the JVM is currently running on.
areAllNumberObsEqual() - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
Tests that every tally in this list contains the same number of observations.
arg(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
arg(double, double) - Static method in class cern.jet.math.tdcomplex.DComplex
 
arg - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
arg(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
arg(float, float) - Static method in class cern.jet.math.tfcomplex.FComplex
 
arg - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
arg() - Method in class jhplot.math.Complex
Argument of this Complex number (the angle in radians with the x-axis in polar coordinates).
ArgumentOutsideDomainException - Exception in org.apache.commons.math
Error thrown when a method is called with an out of bounds argument.
ArgumentOutsideDomainException(double, double, double) - Constructor for exception org.apache.commons.math.ArgumentOutsideDomainException
Constructs an exception with specified formatted detail message.
ArgUtils - Class in org.apache.commons.math.exception.util
Utility class for transforming the list of arguments passed to constructors of exceptions.
Arithmetic - Class in cern.jet.math
Arithmetic functions.
ArithmeticMod - Class in umontreal.iro.lecuyer.util
This class provides facilities to compute multiplications of scalars, of vectors and of matrices modulo m.
armedForcesDay() - Method in class flanagan.math.TimeAndDate
 
armedForcesDay(int) - Method in class flanagan.math.TimeAndDate
 
ARPACK - Class in org.netlib.arpack
ARPACK provider which will attempt to access a native implementation and falling back to use F2J if none is available.
ARPACK() - Constructor for class org.netlib.arpack.ARPACK
 
array() - Method in class flanagan.math.ArrayMaths
 
Array2DRowFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math.linear
Implementation of FieldMatrix using a FieldElement[][] array to store entries.
Array2DRowFieldMatrix(Field<T>) - Constructor for class org.apache.commons.math.linear.Array2DRowFieldMatrix
Creates a matrix with no data
Array2DRowFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math.linear.Array2DRowFieldMatrix
Create a new FieldMatrix with the supplied row and column dimensions.
Array2DRowFieldMatrix(T[][]) - Constructor for class org.apache.commons.math.linear.Array2DRowFieldMatrix
Create a new FieldMatrix using the input array as the underlying data array.
Array2DRowFieldMatrix(T[][], boolean) - Constructor for class org.apache.commons.math.linear.Array2DRowFieldMatrix
Create a new FieldMatrix using the input array as the underlying data array.
Array2DRowFieldMatrix(T[]) - Constructor for class org.apache.commons.math.linear.Array2DRowFieldMatrix
Create a new (column) FieldMatrix using v as the data for the unique column of the v.length x 1 matrix created.
Array2DRowRealMatrix - Class in org.apache.commons.math.linear
Implementation of RealMatrix using a double[][] array to store entries and LU decomposition to support linear system solution and inverse.
Array2DRowRealMatrix() - Constructor for class org.apache.commons.math.linear.Array2DRowRealMatrix
Creates a matrix with no data
Array2DRowRealMatrix(int, int) - Constructor for class org.apache.commons.math.linear.Array2DRowRealMatrix
Create a new RealMatrix with the supplied row and column dimensions.
Array2DRowRealMatrix(double[][]) - Constructor for class org.apache.commons.math.linear.Array2DRowRealMatrix
Create a new RealMatrix using the input array as the underlying data array.
Array2DRowRealMatrix(double[][], boolean) - Constructor for class org.apache.commons.math.linear.Array2DRowRealMatrix
Create a new RealMatrix using the input array as the underlying data array.
Array2DRowRealMatrix(double[]) - Constructor for class org.apache.commons.math.linear.Array2DRowRealMatrix
Create a new (column) RealMatrix using v as the data for the unique column of the v.length x 1 matrix created.
array_as_ArrayList() - Method in class flanagan.math.ArrayMaths
 
array_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
array_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
array_as_byte() - Method in class flanagan.math.ArrayMaths
 
array_as_Byte() - Method in class flanagan.math.ArrayMaths
 
array_as_char() - Method in class flanagan.math.ArrayMaths
 
array_as_Character() - Method in class flanagan.math.ArrayMaths
 
array_as_Complex() - Method in class flanagan.math.ArrayMaths
 
array_as_Complex_columnMatrix() - Method in class flanagan.math.ArrayMaths
 
array_as_Complex_rowMatrix() - Method in class flanagan.math.ArrayMaths
 
array_as_degrees_phase_of_Phasor() - Method in class flanagan.math.ArrayMaths
 
array_as_double() - Method in class flanagan.math.ArrayMaths
 
array_as_Double() - Method in class flanagan.math.ArrayMaths
 
array_as_Float() - Method in class flanagan.math.ArrayMaths
 
array_as_float() - Method in class flanagan.math.ArrayMaths
 
array_as_imaginary_part_of_Complex() - Method in class flanagan.math.ArrayMaths
 
array_as_int() - Method in class flanagan.math.ArrayMaths
 
array_as_Integer() - Method in class flanagan.math.ArrayMaths
 
array_as_long() - Method in class flanagan.math.ArrayMaths
 
array_as_Long() - Method in class flanagan.math.ArrayMaths
 
array_as_magnitude_of_Phasor() - Method in class flanagan.math.ArrayMaths
 
array_as_Matrix_columnMatrix() - Method in class flanagan.math.ArrayMaths
 
array_as_Matrix_rowMatrix() - Method in class flanagan.math.ArrayMaths
 
array_as_modulus_of_Complex() - Method in class flanagan.math.ArrayMaths
 
array_as_Object() - Method in class flanagan.math.ArrayMaths
 
array_as_Phasor() - Method in class flanagan.math.ArrayMaths
 
array_as_Phasor_columnMatrix() - Method in class flanagan.math.ArrayMaths
 
array_as_Phasor_rowMatrix() - Method in class flanagan.math.ArrayMaths
 
array_as_radians_phase_of_Phasor() - Method in class flanagan.math.ArrayMaths
 
array_as_real_part_of_Complex() - Method in class flanagan.math.ArrayMaths
 
array_as_short() - Method in class flanagan.math.ArrayMaths
 
array_as_Short() - Method in class flanagan.math.ArrayMaths
 
array_as_String() - Method in class flanagan.math.ArrayMaths
 
array_as_Vector() - Method in class flanagan.math.ArrayMaths
 
arrayAbs(double[]) - Static method in class flanagan.math.Fmath
 
arrayAbs(float[]) - Static method in class flanagan.math.Fmath
 
arrayAbs(long[]) - Static method in class flanagan.math.Fmath
 
arrayAbs(int[]) - Static method in class flanagan.math.Fmath
 
ArrayFieldVector<T extends FieldElement<T>> - Class in org.apache.commons.math.linear
This class implements the FieldVector interface with a FieldElement array.
ArrayFieldVector(Field<T>) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Build a 0-length vector.
ArrayFieldVector(Field<T>, int) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a (size)-length vector of zeros.
ArrayFieldVector(int, T) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct an (size)-length vector with preset values.
ArrayFieldVector(T[]) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector from an array, copying the input array.
ArrayFieldVector(Field<T>, T[]) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector from an array, copying the input array.
ArrayFieldVector(T[], boolean) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Create a new ArrayFieldVector using the input array as the underlying data array.
ArrayFieldVector(Field<T>, T[], boolean) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Create a new ArrayFieldVector using the input array as the underlying data array.
ArrayFieldVector(T[], int, int) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector from part of a array.
ArrayFieldVector(FieldVector<T>) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector from another vector, using a deep copy.
ArrayFieldVector(ArrayFieldVector<T>) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector from another vector, using a deep copy.
ArrayFieldVector(ArrayFieldVector<T>, boolean) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector from another vector.
ArrayFieldVector(ArrayFieldVector<T>, ArrayFieldVector<T>) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(ArrayFieldVector<T>, T[]) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(T[], ArrayFieldVector<T>) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(T[], T[]) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayFieldVector(Field<T>, T[], T[]) - Constructor for class org.apache.commons.math.linear.ArrayFieldVector
Construct a vector by appending one vector to another vector.
ArrayMaths - Class in flanagan.math
 
ArrayMaths(double[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Double[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(long[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Long[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(float[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Float[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(int[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Integer[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(short[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Short[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(byte[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Byte[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(BigDecimal[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(BigInteger[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Complex[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Phasor[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(char[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Character[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(String[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Object[]) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Stat) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(Vector<Object>) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMaths(ArrayList<Object>) - Constructor for class flanagan.math.ArrayMaths
 
ArrayMathUtils - Class in jhplot.math
Arrays are faster than object, so this class is here to take full advantage of arrays without encapsulation.
arrayMultByConstant(double[], double) - Static method in class flanagan.math.Fmath
 
arrayMultByConstant(int[], double) - Static method in class flanagan.math.Fmath
 
arrayMultByConstant(double[], int) - Static method in class flanagan.math.Fmath
 
arrayMultByConstant(int[], int) - Static method in class flanagan.math.Fmath
 
ArrayOfObservationListener - Interface in umontreal.iro.lecuyer.stat.list
Represents an object that can listen to observations broadcast by lists of statistical probes.
arrayPositiveElementsSum(long[]) - Static method in class flanagan.math.Fmath
 
arrayProduct(double[]) - Static method in class flanagan.math.Fmath
 
arrayProduct(float[]) - Static method in class flanagan.math.Fmath
 
arrayProduct(int[]) - Static method in class flanagan.math.Fmath
 
arrayProduct(long[]) - Static method in class flanagan.math.Fmath
 
ArrayRealVector - Class in org.apache.commons.math.linear
This class implements the RealVector interface with a double array.
ArrayRealVector() - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Build a 0-length vector.
ArrayRealVector(int) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a (size)-length vector of zeros.
ArrayRealVector(int, double) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct an (size)-length vector with preset values.
ArrayRealVector(double[]) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector from an array, copying the input array.
ArrayRealVector(double[], boolean) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Create a new ArrayRealVector using the input array as the underlying data array.
ArrayRealVector(double[], int, int) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector from part of a array.
ArrayRealVector(Double[]) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector from an array.
ArrayRealVector(Double[], int, int) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector from part of a Double array
ArrayRealVector(RealVector) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector from another vector, using a deep copy.
ArrayRealVector(ArrayRealVector) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector from another vector, using a deep copy.
ArrayRealVector(ArrayRealVector, boolean) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector from another vector.
ArrayRealVector(ArrayRealVector, ArrayRealVector) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(ArrayRealVector, RealVector) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(RealVector, ArrayRealVector) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(ArrayRealVector, double[]) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(double[], ArrayRealVector) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
ArrayRealVector(double[], double[]) - Constructor for class org.apache.commons.math.linear.ArrayRealVector
Construct a vector by appending one vector to another vector.
Arrays - Class in cern.colt
Array manipulations; complements java.util.Arrays.
ArrayString - Class in jhplot.math.io
BSD License
ArrayString() - Constructor for class jhplot.math.io.ArrayString
 
arraySum(double[]) - Static method in class flanagan.math.Fmath
 
arraySum(float[]) - Static method in class flanagan.math.Fmath
 
arraySum(int[]) - Static method in class flanagan.math.Fmath
 
arraySum(long[]) - Static method in class flanagan.math.Fmath
 
arrayType() - Method in class flanagan.math.ArrayMaths
 
Arrow - Class in jhplot.shapes
Build an arrow.
Arrow(double, double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.Arrow
Build an arrow
Arrow(double, double, double, double) - Constructor for class jhplot.shapes.Arrow
Build an arrow in
ARROW - Static variable in class jhplot.shapes.HShape
 
ascending(int) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with cells having ascending values.
ascending(int, int) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with cells having ascending values.
ascending(int, int, int) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with cells having ascending values.
ascending(int) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
Constructs a matrix with cells having ascending values.
ascending(int, int) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a matrix with cells having ascending values.
ascending(int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleFactory3D
Constructs a matrix with cells having ascending values.
ascending(int) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
Constructs a matrix with cells having ascending values.
ascending(int, int) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a matrix with cells having ascending values.
ascending(int, int, int) - Method in class cern.colt.matrix.tfloat.FloatFactory3D
Constructs a matrix with cells having ascending values.
ascending(int) - Method in class cern.colt.matrix.tint.IntFactory1D
Constructs a matrix with cells having ascending values.
ascending(int, int) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a matrix with cells having ascending values.
ascending(int, int, int) - Method in class cern.colt.matrix.tint.IntFactory3D
Constructs a matrix with cells having ascending values.
ascending(int) - Method in class cern.colt.matrix.tlong.LongFactory1D
Constructs a matrix with cells having ascending values.
ascending(int, int) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a matrix with cells having ascending values.
ascending(int, int, int) - Method in class cern.colt.matrix.tlong.LongFactory3D
Constructs a matrix with cells having ascending values.
ascensionThursday() - Method in class flanagan.math.TimeAndDate
 
ascensionThursday(int) - Method in class flanagan.math.TimeAndDate
 
ASCIIFile - Class in jhplot.math.io
BSD License
ASCIIFile(File) - Constructor for class jhplot.math.io.ASCIIFile
 
asCollector(BivariateRealFunction, double) - Method in class org.apache.commons.math.analysis.ComposableFunction
Generates a function that iteratively apply instance function on all elements of an array.
asCollector(BivariateRealFunction) - Method in class org.apache.commons.math.analysis.ComposableFunction
Generates a function that iteratively apply instance function on all elements of an array.
asCollector(double) - Method in class org.apache.commons.math.analysis.ComposableFunction
Generates a function that iteratively apply instance function on all elements of an array.
asCollector() - Method in class org.apache.commons.math.analysis.ComposableFunction
Generates a function that iteratively apply instance function on all elements of an array.
asec(double) - Static method in class flanagan.math.Fmath
 
asech(double) - Static method in class flanagan.math.Fmath
 
ashWednesday() - Method in class flanagan.math.TimeAndDate
 
ashWednesday(int) - Method in class flanagan.math.TimeAndDate
 
asin - Static variable in class cern.jet.math.Functions
Function that returns Math.asin(a).
asin(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
asin - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
asin - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.asin(a).
asin(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
asin - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
asin - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.asin(a).
asin(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
asin(double) - Static method in class flanagan.math.Fmath
 
asin(ValueErr) - Static method in class jhplot.math.ValueErr
Inverse sine of a value with error
ASIN - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.asin method wrapped as a ComposableFunction.
asin() - Method in class org.apache.commons.math.complex.Complex
Compute the inverse sine of this complex number.
asin(Dfp) - Static method in class org.apache.commons.math.dfp.DfpMath
computes the arc-sine of the argument.
asin(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the arc sine of a number.
asinh(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
asinh(double) - Static method in class flanagan.math.Fmath
 
asinh(double) - Static method in class jhplot.math.num.special.Trigonometric
Returns the inverse hyperbolic sine of x.
asinh(ValueErr) - Static method in class jhplot.math.ValueErr
Inverse hyperbolic sine of a value with error
asinh(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the inverse hyperbolic sine of a number.
asPackedArray(boolean) - Method in class hephysics.matrix.SymmetricMatrix
Returns the matrix as a packed array
assign(DoubleFunction) - Method in class cern.colt.map.AbstractIntDoubleMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractIntDoubleMap) - Method in class cern.colt.map.AbstractIntDoubleMap
Clears the receiver, then adds all (key,value) pairs of othervalues to it.
assign(DoubleFunction) - Method in class cern.colt.map.OpenIntDoubleHashMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractIntDoubleMap) - Method in class cern.colt.map.OpenIntDoubleHashMap
Clears the receiver, then adds all (key,value) pairs of othervalues to it.
assign(DoubleFunction) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractIntDoubleMap) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(DoubleFunction) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractLongDoubleMap) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(DoubleFunction) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractIntDoubleMap) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(DoubleFunction) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractLongDoubleMap) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(FloatFunction) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractIntFloatMap) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(FloatFunction) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractLongFloatMap) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(FloatFunction) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractIntFloatMap) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(FloatFunction) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractLongFloatMap) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(IntFunction) - Method in class cern.colt.map.tint.AbstractIntIntMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractIntIntMap) - Method in class cern.colt.map.tint.AbstractIntIntMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(LongFunction) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractIntLongMap) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(IntFunction) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractLongIntMap) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(LongFunction) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Assigns the result of a function to each value; v[i] = function(v[i]).
assign(AbstractLongLongMap) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Clears the receiver, then adds all (key,value) pairs of other values to it.
assign(double[]) - Method in class cern.colt.matrix.DoubleMatrix1D
Sets all cells to the state specified by values.
assign(double) - Method in class cern.colt.matrix.DoubleMatrix1D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix1D, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(DoubleMatrix1D, DoubleDoubleFunction, IntArrayList) - Method in class cern.colt.matrix.DoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(double[][]) - Method in class cern.colt.matrix.DoubleMatrix2D
Sets all cells to the state specified by values.
assign(double) - Method in class cern.colt.matrix.DoubleMatrix2D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(double[][][]) - Method in class cern.colt.matrix.DoubleMatrix3D
Sets all cells to the state specified by values.
assign(double) - Method in class cern.colt.matrix.DoubleMatrix3D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix3D
Assigns the result of a function to each cell; x[slice,row,col] = function(x[slice,row,col]).
assign(DoubleMatrix3D) - Method in class cern.colt.matrix.DoubleMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix3D, DoubleDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix3D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(double[]) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Sets all cells to the state specified by values.
assign(double) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(DoubleMatrix1D) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix1D, DoubleDoubleFunction) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(double[][]) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Sets all cells to the state specified by values.
assign(double) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(double[][][]) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
Sets all cells to the state specified by values.
assign(DoubleMatrix3D) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(Object[]) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(ObjectMatrix1D) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix1D, ObjectObjectFunction) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(Object[][]) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(ObjectMatrix2D) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix2D, ObjectObjectFunction) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(Object[][][]) - Method in class cern.colt.matrix.impl.DenseObjectMatrix3D
Sets all cells to the state specified by values.
assign(ObjectMatrix3D) - Method in class cern.colt.matrix.impl.DenseObjectMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(double) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Sets all cells to the state specified by value.
assign(double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Sets all cells to the state specified by value.
assign(DoubleMatrix2D, DoubleFunction) - Method in interface cern.colt.matrix.linalg.Blas
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(DoubleMatrix2D, DoubleMatrix2D, DoubleDoubleFunction) - Method in interface cern.colt.matrix.linalg.Blas
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(DoubleMatrix2D, DoubleFunction) - Method in class cern.colt.matrix.linalg.SeqBlas
 
assign(DoubleMatrix2D, DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.linalg.SeqBlas
 
assign(DoubleMatrix2D, DoubleFunction) - Method in class cern.colt.matrix.linalg.SmpBlas
 
assign(DoubleMatrix2D, DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.linalg.SmpBlas
 
assign(Object[]) - Method in class cern.colt.matrix.ObjectMatrix1D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(ObjectMatrix1D) - Method in class cern.colt.matrix.ObjectMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix1D, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(Object) - Method in class cern.colt.matrix.ObjectMatrix1D
Sets all cells to the state specified by value.
assign(Object[][]) - Method in class cern.colt.matrix.ObjectMatrix2D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix2D, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(Object) - Method in class cern.colt.matrix.ObjectMatrix2D
Sets all cells to the state specified by value.
assign(Object[][][]) - Method in class cern.colt.matrix.ObjectMatrix3D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix3D
Assigns the result of a function to each cell; x[slice,row,col] = function(x[slice,row,col]).
assign(ObjectMatrix3D) - Method in class cern.colt.matrix.ObjectMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix3D, ObjectObjectFunction) - Method in class cern.colt.matrix.ObjectMatrix3D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(Object) - Method in class cern.colt.matrix.ObjectMatrix3D
Sets all cells to the state specified by value.
assign(DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Assigns the result of a function to each cell;
assign(DComplexProcedure, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Assigns the result of a function to all cells that satisfy a condition.
assign(DComplexProcedure, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Assigns a value to all cells that satisfy a condition.
assign(DComplexRealFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Assigns the result of a function to the real part of the receiver.
assign(DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(DComplexMatrix1D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Assigns the result of a function to each cell;
assign(double, double) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Sets all cells to the state specified by re and im.
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Sets all cells to the state specified by values.
assign(DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Assigns the result of a function to each cell;
assign(DComplexProcedure, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Assigns the result of a function to all cells that satisfy a condition.
assign(DComplexProcedure, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Assigns a value to all cells that satisfy a condition.
assign(DComplexRealFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Assigns the result of a function to the real part of the receiver.
assign(DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(DComplexMatrix2D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Assigns the result of a function to each cell.
assign(DComplexMatrix2D, DComplexDComplexDComplexFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Assigns the result of a function to all cells with a given indexes
assign(double, double) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Sets all cells to the state specified by re and im.
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Sets all cells to the state specified by values.
assign(double[][]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Sets all cells to the state specified by values.
assign(float[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Sets all cells to the state specified by values.
assign(DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Assigns the result of a function to each cell.
assign(DComplexRealFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Assigns the result of a function to the real part of the receiver.
assign(DComplexProcedure, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Assigns the result of a function to all cells that satisfy a condition.
assign(DComplexProcedure, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Assigns a value to all cells that satisfy a condition.
assign(DComplexMatrix3D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(DComplexMatrix3D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Assigns the result of a function to each cell.
assign(double, double) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Sets all cells to the state specified by re and im.
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Sets all cells to the state specified by values.
assign(double[][][]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Sets all cells to the state specified by values.
assign(DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assign(DComplexProcedure, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assign(DComplexProcedure, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assign(DComplexRealFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assign(DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assign(DComplexMatrix2D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assign(double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assign(double[][]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assign(DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
assign(DComplexProcedure, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
assign(DComplexProcedure, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
assign(DComplexRealFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
assign(DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
assign(DComplexMatrix1D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
assign(double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
assign(DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assign(DComplexProcedure, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assign(DComplexProcedure, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assign(DComplexRealFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assign(DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assign(DComplexMatrix2D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assign(double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assign(double[][]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assign(DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assign(DComplexProcedure, DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assign(DComplexProcedure, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assign(DComplexRealFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assign(DComplexMatrix3D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assign(DComplexMatrix3D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assign(double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assign(double[][][]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assign(DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
assign(double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
assign(double[][]) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
assign(DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
assign(DComplexMatrix2D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
assign(DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
assign(double, double) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
assign(DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
assign(DComplexMatrix2D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
assign(DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
assign(DComplexMatrix2D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
assign(DComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
assign(double, double) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
assign(DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
assign(DComplexMatrix2D, DComplexDComplexDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
assign(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
assign(DoubleMatrix2D, DoubleFunction) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(DoubleMatrix2D, DoubleMatrix2D, DoubleDoubleFunction) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(DoubleMatrix2D, DoubleFunction) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
assign(DoubleMatrix2D, DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(DoubleProcedure, DoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Assigns the result of a function to all cells that satisfy a condition.
assign(DoubleProcedure, double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Assigns a value to all cells that satisfy a condition.
assign(double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Sets all cells to the state specified by value.
assign(double[]) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Sets all cells to the state specified by values.
assign(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix1D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(DoubleMatrix1D, DoubleDoubleFunction, IntArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(DoubleProcedure, DoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Assigns the result of a function to all cells that satisfy a condition.
assign(DoubleProcedure, double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Assigns a value to all cells that satisfy a condition.
assign(double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Sets all cells to the state specified by value.
assign(double[]) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Sets all cells to the state specified by values.
assign(double[][]) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Sets all cells to the state specified by values.
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(DoubleMatrix2D, DoubleDoubleFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Assigns the result of a function to all cells with a given indexes
assign(float[]) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Sets all cells to the state specified by values.
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Assigns the result of a function to each cell; x[slice,row,col] = function(x[slice,row,col]).
assign(DoubleProcedure, DoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Assigns the result of a function to all cells that satisfy a condition.
assign(DoubleProcedure, double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Assigns a value to all cells that satisfy a condition.
assign(double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Sets all cells to the state specified by value.
assign(double[]) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Sets all cells to the state specified by values.
assign(double[][][]) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Sets all cells to the state specified by values.
assign(DoubleMatrix3D) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(DoubleMatrix3D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(DoubleMatrix3D, DoubleDoubleFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Assigns the result of a function to all cells with a given indexes
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
assign(DoubleProcedure, DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
assign(DoubleProcedure, double) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
assign(double[]) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
assign(double[][]) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
assign(DoubleMatrix2D, DoubleDoubleFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
assign(DoubleProcedure, DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
assign(DoubleProcedure, double) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
assign(double) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
assign(double[]) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
assign(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
assign(DoubleMatrix1D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
assign(DoubleProcedure, DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
assign(DoubleProcedure, double) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
assign(double[]) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
assign(double[][]) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
assign(DoubleMatrix2D, DoubleDoubleFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
assign(DoubleProcedure, DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
assign(DoubleProcedure, double) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
assign(double) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
assign(double[]) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
assign(double[][][]) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
assign(DoubleMatrix3D) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
assign(DoubleMatrix3D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
assign(DoubleMatrix3D, DoubleDoubleFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
assign(double[]) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
assign(double[][]) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Sets all cells to the state specified by value.
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
assign(int[], int[], double, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]), where y is given in the coordinate form with single numerical value.
assign(int[], int[], double[], DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]), where y is given in the coordinate form.
assign(double) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
assign(DoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
assign(double) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
assign(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
assign(double[]) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
assign(DoubleMatrix2D, DoubleDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
assign(FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Assigns the result of a function to each cell;
assign(FComplexProcedure, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Assigns the result of a function to all cells that satisfy a condition.
assign(FComplexProcedure, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Assigns a value to all cells that satisfy a condition.
assign(FComplexRealFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Assigns the result of a function to the real part of the receiver.
assign(FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(FComplexMatrix1D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Assigns the result of a function to each cell;
assign(float, float) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Sets all cells to the state specified by re and im.
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Sets all cells to the state specified by values.
assign(FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Assigns the result of a function to each cell;
assign(FComplexProcedure, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Assigns the result of a function to all cells that satisfy a condition.
assign(FComplexProcedure, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Assigns a value to all cells that satisfy a condition.
assign(FComplexRealFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Assigns the result of a function to the real part of the receiver.
assign(FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(FComplexMatrix2D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Assigns the result of a function to each cell.
assign(FComplexMatrix2D, FComplexFComplexFComplexFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Assigns the result of a function to all cells with a given indexes
assign(float, float) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Sets all cells to the state specified by re and im.
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Sets all cells to the state specified by values.
assign(float[][]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Sets all cells to the state specified by values.
assign(FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Assigns the result of a function to each cell.
assign(FComplexRealFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Assigns the result of a function to the real part of the receiver.
assign(FComplexProcedure, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Assigns the result of a function to all cells that satisfy a condition.
assign(FComplexProcedure, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Assigns a value to all cells that satisfy a condition.
assign(FComplexMatrix3D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(FComplexMatrix3D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Assigns the result of a function to each cell.
assign(float, float) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Sets all cells to the state specified by re and im.
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Sets all cells to the state specified by values.
assign(float[][][]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Sets all cells to the state specified by values.
assign(FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assign(FComplexProcedure, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assign(FComplexProcedure, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assign(FComplexRealFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assign(FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assign(FComplexMatrix2D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assign(float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assign(float[][]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assign(FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
assign(FComplexProcedure, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
assign(FComplexProcedure, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
assign(FComplexRealFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
assign(FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
assign(FComplexMatrix1D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
assign(float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
assign(FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assign(FComplexProcedure, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assign(FComplexProcedure, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assign(FComplexRealFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assign(FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assign(FComplexMatrix2D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assign(float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assign(float[][]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assign(FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assign(FComplexProcedure, FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assign(FComplexProcedure, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assign(FComplexRealFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assign(FComplexMatrix3D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assign(FComplexMatrix3D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assign(float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assign(float[][][]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assign(FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
assign(float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
assign(float[][]) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
assign(FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
assign(FComplexMatrix2D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
assign(FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
assign(float, float) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
assign(FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
assign(FComplexMatrix2D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
assign(FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
assign(FComplexMatrix2D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
assign(FComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
assign(float, float) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
assign(FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
assign(FComplexMatrix2D, FComplexFComplexFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
assign(FloatMatrix2D, FloatFunction) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(FloatMatrix2D, FloatMatrix2D, FloatFloatFunction) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(FloatMatrix2D, FloatFunction) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
assign(FloatMatrix2D, FloatMatrix2D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(FloatProcedure, FloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Assigns the result of a function to all cells that satisfy a condition.
assign(FloatProcedure, float) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Assigns a value to all cells that satisfy a condition.
assign(float) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Sets all cells to the state specified by value.
assign(float[]) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Sets all cells to the state specified by values.
assign(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(FloatMatrix1D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(FloatMatrix1D, FloatFloatFunction, IntArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(FloatProcedure, FloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Assigns the result of a function to all cells that satisfy a condition.
assign(FloatProcedure, float) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Assigns a value to all cells that satisfy a condition.
assign(float) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Sets all cells to the state specified by value.
assign(float[]) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Sets all cells to the state specified by values.
assign(float[][]) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Sets all cells to the state specified by values.
assign(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(FloatMatrix2D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(FloatMatrix2D, FloatFloatFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Assigns the result of a function to all cells with a given indexes
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Assigns the result of a function to each cell; x[slice,row,col] = function(x[slice,row,col]).
assign(FloatProcedure, FloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Assigns the result of a function to all cells that satisfy a condition.
assign(FloatProcedure, float) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Assigns a value to all cells that satisfy a condition.
assign(float) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Sets all cells to the state specified by value.
assign(float[]) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Sets all cells to the state specified by values.
assign(float[][][]) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Sets all cells to the state specified by values.
assign(FloatMatrix3D) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(FloatMatrix3D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(FloatMatrix3D, FloatFloatFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Assigns the result of a function to all cells with a given indexes
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
assign(FloatProcedure, FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
assign(FloatProcedure, float) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
assign(float) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
assign(float[][]) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
assign(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
assign(FloatMatrix2D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
assign(FloatMatrix2D, FloatFloatFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
assign(FloatProcedure, FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
assign(FloatProcedure, float) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
assign(float) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
assign(float[]) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
assign(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
assign(FloatMatrix1D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
assign(FloatProcedure, FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
assign(FloatProcedure, float) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
assign(float) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
assign(float[][]) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
assign(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
assign(FloatMatrix2D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
assign(FloatMatrix2D, FloatFloatFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
assign(FloatProcedure, FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
assign(FloatProcedure, float) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
assign(float) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
assign(float[]) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
assign(float[][][]) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
assign(FloatMatrix3D) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
assign(FloatMatrix3D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
assign(FloatMatrix3D, FloatFloatFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
assign(float) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
assign(float[][]) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
assign(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
assign(FloatMatrix2D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
assign(float) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
assign(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
assign(FloatMatrix2D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
assign(float) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Sets all cells to the state specified by value.
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
assign(float) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
assign(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
assign(FloatMatrix2D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
assign(int[], int[], float, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]), where y is given in the coordinate form with single numerical value.
assign(int[], int[], float[], FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]), where y is given in the coordinate form.
assign(float) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
assign(FloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
assign(float) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
assign(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
assign(FloatMatrix2D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
assign(float[]) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
assign(FloatMatrix2D, FloatFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
assign(IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
assign(IntProcedure, IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
assign(IntProcedure, int) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
assign(int) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
assign(int[]) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
assign(int[][]) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
assign(IntMatrix2D) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
assign(IntMatrix2D, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
assign(IntMatrix2D, IntIntFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
assign(IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
assign(IntProcedure, IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
assign(IntProcedure, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
assign(int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
assign(int[]) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
assign(IntMatrix1D) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
assign(IntMatrix1D, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
assign(IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
assign(IntProcedure, IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
assign(IntProcedure, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
assign(int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
assign(int[]) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
assign(int[][]) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
assign(IntMatrix2D) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
assign(IntMatrix2D, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
assign(IntMatrix2D, IntIntFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
assign(IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
assign(int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
assign(int[]) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
assign(int[][][]) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
assign(IntProcedure, IntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
assign(IntProcedure, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
assign(IntMatrix3D) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
assign(IntMatrix3D, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
assign(IntMatrix3D, IntIntFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
assign(IntFunction) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
assign(int) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
assign(int[]) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
assign(int[][]) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
assign(IntMatrix2D) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
assign(IntMatrix2D, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
assign(IntFunction) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
assign(int) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
assign(IntMatrix2D) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
assign(IntMatrix2D, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
assign(int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Sets all cells to the state specified by value.
assign(IntFunction) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
assign(int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
assign(IntMatrix2D) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
assign(IntMatrix2D, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
assign(int[], int[], int, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]), where y is given in the coordinate form with single numerical value.
assign(int[], int[], int[], IntIntFunction) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]), where y is given in the coordinate form.
assign(int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
assign(IntFunction) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
assign(int) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
assign(IntMatrix2D) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
assign(IntMatrix2D, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
assign(IntMatrix2D, IntIntFunction) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
assign(int[]) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
assign(IntFunction) - Method in class cern.colt.matrix.tint.IntMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(IntProcedure, IntFunction) - Method in class cern.colt.matrix.tint.IntMatrix1D
Assigns the result of a function to all cells that satisfy a condition.
assign(IntProcedure, int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Assigns a value to all cells that satisfy a condition.
assign(int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Sets all cells to the state specified by value.
assign(int[]) - Method in class cern.colt.matrix.tint.IntMatrix1D
Sets all cells to the state specified by values.
assign(IntMatrix1D) - Method in class cern.colt.matrix.tint.IntMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(IntMatrix1D, IntIntFunction) - Method in class cern.colt.matrix.tint.IntMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(IntMatrix1D, IntIntFunction, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(IntFunction) - Method in class cern.colt.matrix.tint.IntMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(IntProcedure, IntFunction) - Method in class cern.colt.matrix.tint.IntMatrix2D
Assigns the result of a function to all cells that satisfy a condition.
assign(IntProcedure, int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Assigns a value to all cells that satisfy a condition.
assign(int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Sets all cells to the state specified by value.
assign(int[]) - Method in class cern.colt.matrix.tint.IntMatrix2D
Sets all cells to the state specified by values.
assign(int[][]) - Method in class cern.colt.matrix.tint.IntMatrix2D
Sets all cells to the state specified by values.
assign(IntMatrix2D) - Method in class cern.colt.matrix.tint.IntMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(IntMatrix2D, IntIntFunction) - Method in class cern.colt.matrix.tint.IntMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(IntMatrix2D, IntIntFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix2D
Assigns the result of a function to all cells with a given indexes
assign(IntFunction) - Method in class cern.colt.matrix.tint.IntMatrix3D
Assigns the result of a function to each cell; x[slice,row,col] = function(x[slice,row,col]).
assign(int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Sets all cells to the state specified by value.
assign(int[]) - Method in class cern.colt.matrix.tint.IntMatrix3D
Sets all cells to the state specified by values.
assign(int[][][]) - Method in class cern.colt.matrix.tint.IntMatrix3D
Sets all cells to the state specified by values.
assign(IntProcedure, IntFunction) - Method in class cern.colt.matrix.tint.IntMatrix3D
Assigns the result of a function to all cells that satisfy a condition.
assign(IntProcedure, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Assigns a value to all cells that satisfy a condition.
assign(IntMatrix3D) - Method in class cern.colt.matrix.tint.IntMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(IntMatrix3D, IntIntFunction) - Method in class cern.colt.matrix.tint.IntMatrix3D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(IntMatrix3D, IntIntFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix3D
Assigns the result of a function to all cells with a given indexes
assign(LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
assign(LongProcedure, LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
assign(LongProcedure, long) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
assign(long) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
assign(long[]) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
assign(long[][]) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
assign(LongMatrix2D) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
assign(LongMatrix2D, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
assign(LongMatrix2D, LongLongFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
assign(LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
assign(LongProcedure, LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
assign(LongProcedure, long) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
assign(long) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
assign(long[]) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
assign(int[]) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
assign(LongMatrix1D) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
assign(LongMatrix1D, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
assign(LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
assign(LongProcedure, LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
assign(LongProcedure, long) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
assign(long) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
assign(long[]) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
assign(int[]) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
assign(long[][]) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
assign(LongMatrix2D) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
assign(LongMatrix2D, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
assign(LongMatrix2D, LongLongFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
assign(LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
assign(long) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
assign(long[]) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
assign(int[]) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
assign(long[][][]) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
assign(LongProcedure, LongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
assign(LongProcedure, long) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
assign(LongMatrix3D) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
assign(LongMatrix3D, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
assign(LongMatrix3D, LongLongFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
assign(LongFunction) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
assign(long) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
assign(long[]) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
assign(long[][]) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
assign(LongMatrix2D) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
assign(LongMatrix2D, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
assign(LongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
assign(long) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
assign(LongMatrix2D) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
assign(LongMatrix2D, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
assign(long) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Sets all cells to the state specified by value.
assign(LongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
assign(long) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
assign(LongMatrix2D) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
assign(LongMatrix2D, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
assign(int[], int[], long, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]), where y is given in the coordinate form with single numerical value.
assign(int[], int[], long[], LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]), where y is given in the coordinate form.
assign(long) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
assign(LongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
assign(long) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
assign(LongMatrix2D) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
assign(LongMatrix2D, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
assign(LongMatrix2D, LongLongFunction) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
assign(int[]) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
assign(long[]) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
assign(LongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(LongProcedure, LongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Assigns the result of a function to all cells that satisfy a condition.
assign(LongProcedure, long) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Assigns a value to all cells that satisfy a condition.
assign(long) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Sets all cells to the state specified by value.
assign(long[]) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Sets all cells to the state specified by values.
assign(int[]) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Sets all cells to the state specified by values.
assign(LongMatrix1D) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(LongMatrix1D, LongLongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(LongMatrix1D, LongLongFunction, IntArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(LongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(LongProcedure, LongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Assigns the result of a function to all cells that satisfy a condition.
assign(LongProcedure, long) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Assigns a value to all cells that satisfy a condition.
assign(long) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Sets all cells to the state specified by value.
assign(long[]) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Sets all cells to the state specified by values.
assign(int[]) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Sets all cells to the state specified by values.
assign(long[][]) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Sets all cells to the state specified by values.
assign(LongMatrix2D) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(LongMatrix2D, LongLongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(LongMatrix2D, LongLongFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Assigns the result of a function to all cells with a given indexes
assign(LongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Assigns the result of a function to each cell; x[slice,row,col] = function(x[slice,row,col]).
assign(long) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Sets all cells to the state specified by value.
assign(long[]) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Sets all cells to the state specified by values.
assign(int[]) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Sets all cells to the state specified by values.
assign(long[][][]) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Sets all cells to the state specified by values.
assign(LongProcedure, LongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Assigns the result of a function to all cells that satisfy a condition.
assign(LongProcedure, long) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Assigns a value to all cells that satisfy a condition.
assign(LongMatrix3D) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(LongMatrix3D, LongLongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(LongMatrix3D, LongLongFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Assigns the result of a function to all cells with a given indexes
assign(ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
assign(ObjectProcedure, ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
assign(ObjectProcedure, Object) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
assign(Object) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
assign(Object[]) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
assign(Object[][]) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
assign(ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
assign(ObjectMatrix2D, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
assign(ObjectMatrix2D, ObjectObjectFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
assign(Object[]) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(ObjectMatrix1D) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix1D, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(Object) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
 
assign(Object) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
assign(Object[][]) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(ObjectProcedure, ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
assign(ObjectProcedure, Object) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
assign(ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix2D, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(Object[]) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
assign(ObjectMatrix2D, ObjectObjectFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
assign(Object[][][]) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
Sets all cells to the state specified by values.
assign(Object[]) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
assign(Object) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
assign(ObjectProcedure, ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
assign(ObjectProcedure, Object) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
assign(ObjectMatrix3D) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
assign(ObjectMatrix3D, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
assign(ObjectMatrix3D, ObjectObjectFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
assign(ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
assign(Object) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
assign(Object[]) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
assign(Object[][]) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
assign(ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
assign(ObjectMatrix2D, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
assign(ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
assign(Object) - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
assign(ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
assign(ObjectFunction) - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
assign(Object) - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
assign(ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
assign(ObjectMatrix2D, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
assign(int[]) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
assign(Object[]) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
assign(Object[]) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i]).
assign(ObjectMatrix1D) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix1D, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Assigns the result of a function to each cell; x[i] = function(x[i],y[i]).
assign(Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Sets all cells to the state specified by value.
assign(Object[][]) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col]).
assign(ObjectProcedure, ObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Assigns the result of a function to all cells that satisfy a condition.
assign(ObjectProcedure, Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Assigns a value to all cells that satisfy a condition.
assign(Object[]) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Sets all cells to the state specified by values.
assign(ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix2D, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(ObjectMatrix2D, ObjectObjectFunction, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Assigns the result of a function to all cells with a given indexes
assign(Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Sets all cells to the state specified by value.
assign(ObjectProcedure, ObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Assigns the result of a function to all cells that satisfy a condition.
assign(ObjectProcedure, Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Assigns a value to all cells that satisfy a condition.
assign(Object[][][]) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Sets all cells to the state specified by values.
assign(Object[]) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Sets all cells to the state specified by values.
assign(ObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Assigns the result of a function to each cell; x[slice,row,col] = function(x[slice,row,col]).
assign(ObjectMatrix3D) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Replaces all cell values of the receiver with the values of another matrix.
assign(ObjectMatrix3D, ObjectObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Assigns the result of a function to each cell; x[row,col] = function(x[row,col],y[row,col]).
assign(ObjectMatrix3D, ObjectObjectFunction, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Assigns the result of a function to all cells with a given indexes
assign(Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Sets all cells to the state specified by value.
assignImaginary(DoubleMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Replaces imaginary part of the receiver with the values of another real matrix.
assignImaginary(DoubleMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Replaces imaginary part of the receiver with the values of another real matrix.
assignImaginary(DoubleMatrix3D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Replaces imaginary part of the receiver with the values of another real matrix.
assignImaginary(DoubleMatrix2D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assignImaginary(DoubleMatrix1D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
assignImaginary(DoubleMatrix2D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assignImaginary(DoubleMatrix3D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assignImaginary(FloatMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Replaces imaginary part of the receiver with the values of another real matrix.
assignImaginary(FloatMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Replaces imaginary part of the receiver with the values of another real matrix.
assignImaginary(FloatMatrix3D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Replaces imaginary part of the receiver with the values of another real matrix.
assignImaginary(FloatMatrix2D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assignImaginary(FloatMatrix1D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
assignImaginary(FloatMatrix2D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assignImaginary(FloatMatrix3D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assignReal(DoubleMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Replaces real part of the receiver with the values of another real matrix.
assignReal(DoubleMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Replaces real part of the receiver with the values of another real matrix.
assignReal(DoubleMatrix3D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Replaces real part of the receiver with the values of another real matrix.
assignReal(DoubleMatrix2D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
assignReal(DoubleMatrix1D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
assignReal(DoubleMatrix2D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
assignReal(DoubleMatrix3D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
assignReal(FloatMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Replaces real part of the receiver with the values of another real matrix.
assignReal(FloatMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Replaces real part of the receiver with the values of another real matrix.
assignReal(FloatMatrix3D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Replaces real part of the receiver with the values of another real matrix.
assignReal(FloatMatrix2D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
assignReal(FloatMatrix1D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
assignReal(FloatMatrix2D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
assignReal(FloatMatrix3D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
assignToCluster(int) - Method in class jminhep.cluster.DataPoint
Assigns the data point to a cluster
asString() - Static method in class cern.colt.Version
Returns all version information as string.
assumption() - Method in class flanagan.math.TimeAndDate
 
assumption(int) - Method in class flanagan.math.TimeAndDate
 
atan - Static variable in class cern.jet.math.Functions
Function that returns Math.atan(a).
atan(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
atan - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
atan - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.atan(a).
atan(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
atan - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
atan - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.atan(a).
atan(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
atan(double) - Static method in class flanagan.math.Fmath
 
atan(ValueErr) - Static method in class jhplot.math.ValueErr
inverse tangent of a value
ATAN - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.atan method wrapped as a ComposableFunction.
atan() - Method in class org.apache.commons.math.complex.Complex
Compute the inverse tangent of this complex number.
atan(Dfp) - Static method in class org.apache.commons.math.dfp.DfpMath
computes the arc tangent of the argument Uses the typical taylor series but may reduce arguments using the following identity tan(x+y) = (tan(x) + tan(y)) / (1 - tan(x)*tan(y)) since tan(PI/8) = sqrt(2)-1, atan(x) = atan( (x - sqrt(2) + 1) / (1+x*sqrt(2) - x) + PI/8.0
atan(double) - Static method in class org.apache.commons.math.util.FastMath
Arctangent function
atan2 - Static variable in class cern.jet.math.Functions
Function that returns Math.atan2(a,b).
atan2 - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.atan2(a,b).
atan2 - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.atan2(a,b).
atan2(ErrorProp, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
atan2(ErrorProp, ErrorProp, double) - Static method in class flanagan.analysis.ErrorProp
 
atan2(double, double) - Static method in class flanagan.math.Fmath
 
atan2(ValueErr, ValueErr) - Static method in class jhplot.math.ValueErr
Inverse tangent (atan2) of a value without correlations
atan2(ValueErr, ValueErr, double) - Static method in class jhplot.math.ValueErr
Inverse tangent (atan2) of a value with a correlation
ATAN2 - Static variable in class org.apache.commons.math.analysis.BinaryFunction
Deprecated. The FastMath.atan2 method wrapped as a BinaryFunction.
atan2(double, double) - Static method in class org.apache.commons.math.util.FastMath
Two arguments arctangent function
atanh(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
atanh(double) - Static method in class flanagan.math.Fmath
 
atanh(double) - Static method in class jhplot.math.num.special.Trigonometric
Returns the inverse hyperbolic tangent of x.
atanh(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the inverse hyperbolic tangent of a number.
atmosphere - Static variable in class cern.clhep.Units
 
auto() - Method in class jhplot.bsom.BsomDemo
Set auto mode
AUTO_BOUNDS - Static variable in class jhplot.math.Slicing
 
autoCorrelation(DoubleArrayList, int, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the auto-correlation of a data sequence.
autoCorrelation(DoubleArrayList, int, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the auto-correlation of a data sequence.
autoCorrelation(FloatArrayList, int, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the auto-correlation of a data sequence.
availableFitEngines() - Method in class hep.aida.ref.fitter.FitFactory
Get the list the fit engines provided by the used implementation (e.g.
availableFitMethods() - Method in class hep.aida.ref.fitter.FitFactory
Get the list the fit methods provided by the used implementation (e.g.
average() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Returns the time-average since the last initialization to the last call to update.
average(double[]) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
For each probe in this list, computes the average by calling average, and stores the results into the array a.
average(double[]) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
Computes the average for each tally in this list, and stores the averages in the array r.
average() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Returns the average for this collector.
average() - Method in class umontreal.iro.lecuyer.stat.Tally
 
averageIdenticalAbscissae() - Method in class flanagan.interpolation.BiCubicSpline
 
averageIdenticalAbscissae() - Method in class flanagan.interpolation.BiCubicSplineFirstDerivative
 
averageIdenticalAbscissae() - Method in class flanagan.interpolation.BiCubicSplinePartialDerivative
 
averageIdenticalAbscissae() - Method in class flanagan.interpolation.CubicSpline
 
averageIdenticalAbscissae() - Method in class flanagan.interpolation.PolyCubicSpline
 
averageIdenticalAbscissae() - Method in class flanagan.interpolation.QuadriCubicSpline
 
averageIdenticalAbscissae() - Method in class flanagan.interpolation.TriCubicSpline
 
AverageMathFunction - Class in umontreal.iro.lecuyer.functions
Represents a function computing the average of several functions.
AverageMathFunction(MathFunction...) - Constructor for class umontreal.iro.lecuyer.functions.AverageMathFunction
Constructs a function computing the average of the functions in the array func.
avers(double) - Static method in class flanagan.math.Fmath
 
Avogadro - Static variable in class cern.clhep.PhysicalConstants
 
axis() - Method in class hep.aida.ref.histogram.Histogram1D
Get the X axis.
axis() - Method in class hep.aida.ref.histogram.Profile1D
 
Axis - Class in umontreal.iro.lecuyer.charts
Represents an axis of a chart encapsulated by an instance of XYChart.
Axis(NumberAxis, boolean) - Constructor for class umontreal.iro.lecuyer.charts.Axis
Create a new Axis instance from an existing NumberAxis instance with vertical (y-axis) or horizontal (x-axis) orientation.
axisExponent(int) - Method in class jhplot.jadraw.JaAxes
Get exponent for the axis
axisLengthX() - Method in class jhplot.HPlot
Length of X axis
axisLengthY() - Method in class jhplot.HPlot
Length of Y axis

B

backward() - Method in class flanagan.integration.Integration
 
backward(int) - Method in class flanagan.integration.Integration
 
backward(IntegralFunction, double, double, int) - Static method in class flanagan.integration.Integration
 
backwardSolve(DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Solves the upper triangular system U*x=b;
backwardSolve(FloatMatrix2D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Solves the upper triangular system U*x=b;
BakerTransformedPointSet - Class in umontreal.iro.lecuyer.hups
This container class embodies a point set to which a Baker transformation is applied.
BakerTransformedPointSet(PointSet) - Constructor for class umontreal.iro.lecuyer.hups.BakerTransformedPointSet
Constructs a Baker-transformed point set from the given point set P.
BakerTransformedStream - Class in umontreal.iro.lecuyer.rng
This container class permits one to apply the baker's transformation to the output of any RandomStream.
BakerTransformedStream(RandomStream) - Constructor for class umontreal.iro.lecuyer.rng.BakerTransformedStream
Constructs a new baker transformed stream, using the random numbers from the base stream stream.
bar - Static variable in class cern.clhep.Units
 
barF(double) - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
Computes the complementary distribution function bar(F)n(x) with parameter n.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDistQuick
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDistQuick
Computes the complementary distribution function bar(F)n(x) with parameter n.
barF(int) - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
 
barF(double, int) - Static method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Returns the complementary Bernoulli distribution function bar(F)(x) = P[X >= x] with parameter p.
barF(double, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Same as barF (alpha, beta, 0, 1, d, x).
barF(double, double, double, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
 
barF(double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Returns the complementary distribution function.
barF(int) - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
 
barF(int, double, int) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Returns bar(F)(x) = P[X >= x], the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.CauchyDist
Computes the complementary distribution.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.ChiDist
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiDist
Computes the complementary distribution.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
 
barF(int, int, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Computes the complementary chi-square distribution function with n degrees of freedom, evaluated at x.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Computes the complementary noncentral chi-square distribution function with ν = nu degrees of freedom and parameter λ = lambda.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Returns the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Computes the complementary distribution function bar(F)n(x) with parameter n.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
 
barF(double) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
Returns bar(F)(x), the complementary distribution function.
barF(int) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
Returns bar(F)(x), the complementary distribution function.
barF(double) - Method in interface umontreal.iro.lecuyer.probdist.Distribution
Returns bar(F)(x) = 1 - F(x).
barF(double) - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
 
barF(int, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.ErlangDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
 
barF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated.  
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
 
barF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Computes the complementary distribution function of the fatigue life distribution with parameters μ, β and γ.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
 
barF(int, int, int, double) - Static method in class umontreal.iro.lecuyer.probdist.FisherFDist
Computes the complementary distribution function of the Fisher F distribution with parameters n and m, evaluated at x, with roughly d decimal digits of precision.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
 
barF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FrechetDist
Computes and returns the complementary distribution function 1 - F(x).
barF(double) - Method in class umontreal.iro.lecuyer.probdist.GammaDist
 
barF(double, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Computes the complementary distribution function.
barF(double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Same as barF (alpha, 1.0, d, x).
barF(int) - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
 
barF(double, int) - Static method in class umontreal.iro.lecuyer.probdist.GeometricDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Computes and returns the complementary distribution function 1 - F(x).
barF(double) - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Computes the complementary distribution function of the hyperbolic secant distribution with parameters μ and σ.
barF(int) - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
 
barF(int, int, int, int) - Static method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Computes the complementary distribution function of the inverse gamma distribution with shape parameter α and scale parameter β.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Computes the complementary distribution function of the inverse gaussian distribution with parameters μ and λ, evaluated at x.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
 
barF(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Computes the complementary distribution.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
 
barF(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Computes the complementary distribution function 1 - F(x).
barF(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
Computes the complementary distribution function bar(F)(x) with parameter n.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDistQuick
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDistQuick
Computes the complementary distribution P[Dn >= x] with parameter n, in a form that is more precise in the upper tail, using the program described in.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
Computes the complementary distribution function bar(F)n(x) with parameter n.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Computes the Laplace complementary distribution function.
barF(int) - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
 
barF(double, int) - Static method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LogisticDist
Computes the complementary distribution function 1 - F(x).
barF(double) - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Computes the complementary distribution function of the log-logistic distribution with parameters α and β.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LognormalDist
Computes the lognormal complementary distribution function bar(F)(x), using NormalDist.barF01.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
 
barF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Computes the complementary distribution function.
barF(int) - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
 
barF(double) - Method in class umontreal.iro.lecuyer.probdist.NormalDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Computes the complementary normal distribution function bar(F)(x) = 1 - Φ((x - μ)/σ), with mean μ and variance σ2.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.NormalDistQuick
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDistQuick
Returns an approximation of 1 - Φ(x), where Φ is the standard normal distribution function, with mean 0 and variance 1.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
 
barF(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
NOT IMPLEMENTED.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ParetoDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Computes the complementary distribution function of a Pearson V distribution with shape parameter α and scale parameter β.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
 
barF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Computes the complementary distribution function of a Pearson VI distribution with shape parameters α1 and α2, and scale parameter β.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
 
barF(int) - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
 
barF(double, int) - Static method in class umontreal.iro.lecuyer.probdist.PoissonDist
Computes and returns the value of the complementary Poisson distribution function, for λ = lambda.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.PowerDist
 
barF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.PowerDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Computes the complementary distribution function.
barF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Same as barF (0, beta, x).
barF(double) - Method in class umontreal.iro.lecuyer.probdist.StudentDist
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.StudentDist
Computes the complementary distribution function v = bar(F)(x) with n degrees of freedom.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.StudentDistQuick
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.StudentDistQuick
Computes the complementary distribution function bar(F)(x).
barF(double) - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
 
barF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.TriangularDist
Computes the complementary distribution function.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
 
barF(double) - Method in class umontreal.iro.lecuyer.probdist.UniformDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.UniformDist
Computes the uniform complementary distribution function bar(F)(x).
barF(int) - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
 
barF(int, int, int) - Static method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Computes the discrete uniform complementary distribution function bar(F)(x).
barF(double) - Method in class umontreal.iro.lecuyer.probdist.WatsonGDist
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.WatsonGDist
Computes the complementary distribution function bar(F)n(x) with parameter n.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
 
barF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.WatsonUDist
Computes the complementary distribution function bar(F)n(x), where Fn is the Watson U distribution with parameter n.
barF(double) - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
 
barF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Computes the complementary distribution function.
barF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Same as barF (alpha, 1, 0, x).
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Computes the standard upper binormal distribution with μ1 = μ2 = 0 and σ1 = σ2 = 1.
barF(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
 
barF(double, double, double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Computes the upper binormal distribution function with parameters μ1 = mu1, μ2 = mu2, σ1 = sigma1, σ2 = sigma2 and ρ = rho.
barF(double, double, double, double, double, double, double, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
Computes the upper binormal distribution function with parameters μ1 = mu1, μ2 = mu2, σ1 = sigma1, σ2 = sigma2, ρ = rho and ndig decimal digits of accuracy.
barF(double, double, double, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
Computes the upper standard binormal distribution function with parameters ρ = rho and ndig decimal digits of accuracy.
barF(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
 
barF(double, double, double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
 
barF(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalGenzDist
 
barF(double, double, double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalGenzDist
 
barF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalGenzDist
 
barF(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
 
barF(int, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
Computes the standard upper bivariate Student's t distribution.
barF(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistribution2Dim
.
barF01(double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Same as barF (0, 1, x).
barF01(double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDistQuick
Same as barF (0.0, 1.0, x).
barn - Static variable in class cern.clhep.Units
 
baseEditPanel(JaxoLineOptionsPanel) - Method in class jhplot.jadraw.JaLineObject
Adds components to the edit panel that are common to all line objects.
BaseModelFunction - Class in hep.aida.ref.function
 
BaseModelFunction(String, String, IFunction) - Constructor for class hep.aida.ref.function.BaseModelFunction
 
BaseModelFunction(String, String, FunctionCore, FunctionCore) - Constructor for class hep.aida.ref.function.BaseModelFunction
 
BaseRecordsFile - Class in jhplot.io
 
BasicBinner1D - Class in hep.aida.ref.histogram.binner
 
BasicBinner1D(int) - Constructor for class hep.aida.ref.histogram.binner.BasicBinner1D
 
BasicBinner1D(Binner1D) - Constructor for class hep.aida.ref.histogram.binner.BasicBinner1D
 
BasicBinner2D - Class in hep.aida.ref.histogram.binner
 
BasicBinner2D(int, int) - Constructor for class hep.aida.ref.histogram.binner.BasicBinner2D
Creates a new instance of OneDBinner.
BasicBinner3D - Class in hep.aida.ref.histogram.binner
 
BasicBinner3D(int, int, int) - Constructor for class hep.aida.ref.histogram.binner.BasicBinner3D
Creates a new instance of OneDBinner.
basicFft(double[], int, int) - Method in class flanagan.math.FourierTransform
 
BasicMatrix - Class in hephysics.matrix
A very simple matrix implementation
BasicMatrix(int, int) - Constructor for class hephysics.matrix.BasicMatrix
 
BasicMatrix(double, double, double, double, double, double, double, double, double) - Constructor for class hephysics.matrix.BasicMatrix
 
BasicMatrix(double[][]) - Constructor for class hephysics.matrix.BasicMatrix
Creates a new instance of BasicMatrix
BasicMatrix(Matrix) - Constructor for class hephysics.matrix.BasicMatrix
 
BasicRandomStreamFactory - Class in umontreal.iro.lecuyer.rng
Represents a basic random stream factory that can constructs new instances of a given RandomStream implementation via the newInstance method.
BasicRandomStreamFactory(Class) - Constructor for class umontreal.iro.lecuyer.rng.BasicRandomStreamFactory
Constructs a new basic random stream factory with random stream class rsClass.
BatchAnalysisFactory - Class in hep.aida.ref
 
BatchAnalysisFactory() - Constructor for class hep.aida.ref.BatchAnalysisFactory
 
BB_MAX_X - Static variable in class jhplot.jadraw.JaObject
The component of the boundingbox array that contains the upper x value of the boundingbox.
BB_MAX_Y - Static variable in class jhplot.jadraw.JaObject
The component of the boundingbox array that contains the upper y value of the boundingbox.
BB_MIN_X - Static variable in class jhplot.jadraw.JaObject
The component of the boundingbox array that contains the lower x value of the boundingbox.
BB_MIN_Y - Static variable in class jhplot.jadraw.JaObject
The component of the boundingbox array that contains the lower y value of the boundingbox.
becquerel - Static variable in class cern.clhep.Units
 
beforeInsert(int, boolean) - Method in class cern.colt.list.AbstractBooleanList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, byte) - Method in class cern.colt.list.AbstractByteList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, char) - Method in class cern.colt.list.AbstractCharList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, double) - Method in class cern.colt.list.AbstractDoubleList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, float) - Method in class cern.colt.list.AbstractFloatList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, int) - Method in class cern.colt.list.AbstractIntList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, long) - Method in class cern.colt.list.AbstractLongList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, short) - Method in class cern.colt.list.AbstractShortList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, boolean) - Method in class cern.colt.list.BooleanArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, byte) - Method in class cern.colt.list.ByteArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, char) - Method in class cern.colt.list.CharArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, double) - Method in class cern.colt.list.DoubleArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, float) - Method in class cern.colt.list.FloatArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, int) - Method in class cern.colt.list.IntArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, long) - Method in class cern.colt.list.LongArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, Object) - Method in class cern.colt.list.ObjectArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, short) - Method in class cern.colt.list.ShortArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, boolean) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, boolean) - Method in class cern.colt.list.tboolean.BooleanArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, byte) - Method in class cern.colt.list.tbyte.AbstractByteList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, byte) - Method in class cern.colt.list.tbyte.ByteArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, char) - Method in class cern.colt.list.tchar.AbstractCharList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, char) - Method in class cern.colt.list.tchar.CharArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, double) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, double) - Method in class cern.colt.list.tdouble.DoubleArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, float) - Method in class cern.colt.list.tfloat.AbstractFloatList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, float) - Method in class cern.colt.list.tfloat.FloatArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, int) - Method in class cern.colt.list.tint.AbstractIntList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, int) - Method in class cern.colt.list.tint.IntArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, long) - Method in class cern.colt.list.tlong.AbstractLongList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, long) - Method in class cern.colt.list.tlong.LongArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, Object) - Method in class cern.colt.list.tobject.ObjectArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, short) - Method in class cern.colt.list.tshort.AbstractShortList
Inserts the specified element before the specified position into the receiver.
beforeInsert(int, short) - Method in class cern.colt.list.tshort.ShortArrayList
Inserts the specified element before the specified position into the receiver.
beforeInsertAllOf(int, Collection) - Method in class cern.colt.list.AbstractList
Inserts all elements of the specified collection before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractBooleanList, int, int) - Method in class cern.colt.list.AbstractBooleanList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractByteList, int, int) - Method in class cern.colt.list.AbstractByteList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractCharList, int, int) - Method in class cern.colt.list.AbstractCharList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractDoubleList, int, int) - Method in class cern.colt.list.AbstractDoubleList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractFloatList, int, int) - Method in class cern.colt.list.AbstractFloatList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractIntList, int, int) - Method in class cern.colt.list.AbstractIntList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractLongList, int, int) - Method in class cern.colt.list.AbstractLongList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractShortList, int, int) - Method in class cern.colt.list.AbstractShortList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, ObjectArrayList, int, int) - Method in class cern.colt.list.ObjectArrayList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractBooleanList, int, int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractByteList, int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractCharList, int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractDoubleList, int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractFloatList, int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractIntList, int, int) - Method in class cern.colt.list.tint.AbstractIntList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractLongList, int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, ObjectArrayList, int, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
beforeInsertAllOfFromTo(int, AbstractShortList, int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Inserts the part of the specified list between otherFrom (inclusive) and otherTo (inclusive) before the specified position into the receiver.
belowWithin(Rectangle, Dimension) - Static method in class jhplot.v3d.Util
 
belowWithin(Component, Component) - Static method in class jhplot.v3d.Util
 
Benchmark - Class in cern.colt.map
Benchmarks the classes of this package.
benchmark(int, int, String) - Static method in class cern.colt.map.Benchmark
 
Benchmark - Class in cern.jet.random
Benchmarks random number generation from various distributions as well as PDF and CDF lookups.
Benchmark - Class in cern.jet.random.engine
Benchmarks the performance of the currently provided uniform pseudo-random number generation engines.
benchmark(int) - Static method in class cern.jet.random.engine.Benchmark
Benchmarks raw() for various uniform generation engines.
BenchmarkMatrix - Class in cern.colt.matrix.bench
Configurable matrix benchmark.
BernoulliDist - Class in umontreal.iro.lecuyer.probdist
Extends the class DiscreteDistributionInt for the Bernoulli distribution with parameter p, where 0 <= p <= 1.
BernoulliDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.BernoulliDist
Creates a Bernoulli distribution object.
BernoulliGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the Bernoulli distribution (see class BernoulliDist).
BernoulliGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.BernoulliGen
Creates a Bernoulli random variate generator with parameter p, using stream s.
BernoulliGen(RandomStream, BernoulliDist) - Constructor for class umontreal.iro.lecuyer.randvar.BernoulliGen
Creates a random variate generator for the Bernoulli distribution dist and the random stream s.
bernoulliPoly(int, double) - Static method in class umontreal.iro.lecuyer.util.Num
Evaluates the Bernoulli polynomial Bn(x) of degree n at x.
BernoulliRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Bernoulli distribution.
BernoulliRandomVariable() - Constructor for class jhplot.math.num.random.BernoulliRandomVariable
Default constructor.
BernoulliRandomVariable(double) - Constructor for class jhplot.math.num.random.BernoulliRandomVariable
Create a random variable with the given probability of success.
BernoulliRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.BernoulliRandomVariable
Create a random variable with the given probability of success and source generator.
Bessel - Class in cern.jet.math
Bessel and Airy functions.
Bessel - Class in cern.jet.math.tdouble
Bessel and Airy functions.
besselK025(double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of K1/4(x), where Ka is the modified Bessel's function of the second kind.
bestPolynomial() - Method in class flanagan.analysis.Regression
 
bestPolynomialPlot(String, String) - Method in class flanagan.analysis.Regression
 
bestPolynomialPlot() - Method in class flanagan.analysis.Regression
 
Beta - Class in cern.jet.random
Beta distribution; math definition and animated definition.
Beta(double, double, RandomEngine) - Constructor for class cern.jet.random.Beta
Constructs a Beta distribution.
Beta - Class in cern.jet.random.tdouble
Beta distribution; math definition and animated definition.
Beta(double, double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.Beta
Constructs a Beta distribution.
beta(double, double) - Static method in class cern.jet.stat.Gamma
Returns the beta function of the arguments.
beta(double, double, double) - Static method in class cern.jet.stat.Probability
Returns the area from zero to x under the beta density function.
beta(double, double) - Static method in class cern.jet.stat.tdouble.Gamma
Returns the beta function of the arguments.
beta(double, double, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the area from zero to x under the beta density function.
beta - Variable in class flanagan.analysis.LogNormalThreeParFunct
 
beta() - Method in class flanagan.analysis.Regression
 
beta(double, double) - Static method in class flanagan.analysis.Stat
 
Beta - Class in jhplot.math.num.pdf
The Beta distribution (1).
Beta() - Constructor for class jhplot.math.num.pdf.Beta
Default constructor.
Beta(double, double) - Constructor for class jhplot.math.num.pdf.Beta
Create a distribution with the given alpha and beta values.
Beta - Class in jhplot.math.num.special
Utility class that provides methods related to the beta family of functions.
beta(double, double) - Static method in class jhplot.math.Random
Generate a random number from a beta random variable.
Beta - Class in org.apache.commons.math.special
This is a utility class that provides computation methods related to the Beta family of functions.
betaArray(double, double, int) - Method in class flanagan.math.PsRandom
 
betaArray(double, double, double, double, int) - Method in class flanagan.math.PsRandom
 
betaCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
betaCDF(double, double, double, double, double) - Static method in class flanagan.analysis.Stat
 
betaComplemented(double, double, double) - Static method in class cern.jet.stat.Probability
Returns the area under the right hand tail (from x to infinity) of the beta density function.
betaComplemented(double, double, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the area under the right hand tail (from x to infinity) of the beta density function.
BetaDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the beta distribution with shape parameters α > 0 and β > 0, over the interval (a, b), where a < b.
BetaDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.BetaDist
Constructs a BetaDist object with parameters α = alpha and β = beta and default domain (0, 1).
BetaDist(double, double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.BetaDist
Constructs a BetaDist object with parameters α = alpha and β = beta, and domain (a, b).
BetaDist(double, double, int) - Constructor for class umontreal.iro.lecuyer.probdist.BetaDist
Constructs a BetaDist object with parameters α = alpha and β = beta, and approximations of roughly d decimal digits of precision when computing the distribution, complementary distribution, and inverse functions.
BetaDist(double, double, double, double, int) - Constructor for class umontreal.iro.lecuyer.probdist.BetaDist
Constructs a BetaDist object with parameters α = alpha and β = beta, and approximations of roughly d decimal digits of precision when computing distribution, complementary distribution, and inverse functions.
BetaDistribution - Interface in org.apache.commons.math.distribution
Computes the cumulative, inverse cumulative and density functions for the beta distribuiton.
BetaDistributionImpl - Class in org.apache.commons.math.distribution
Implements the Beta distribution.
BetaDistributionImpl(double, double, double) - Constructor for class org.apache.commons.math.distribution.BetaDistributionImpl
Build a new instance.
BetaDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.BetaDistributionImpl
Build a new instance.
betaFunction(double, double) - Static method in class flanagan.analysis.Stat
 
BetaGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators with the beta distribution with shape parameters α > 0 and β > 0, over the interval (a, b), where a < b.
BetaGen(RandomStream, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaGen
Creates a new beta generator with parameters α = alpha and β = beta, over the interval (a, b), using stream s.
BetaGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaGen
Creates a new beta generator with parameters α = alpha and β = beta, over the interval (0, 1), using stream s.
BetaGen(RandomStream, BetaDist) - Constructor for class umontreal.iro.lecuyer.randvar.BetaGen
Creates a new generator for the distribution dist, using stream s.
betaMean(double, double) - Static method in class flanagan.analysis.Stat
 
betaMean(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
betaMinMax() - Method in class flanagan.analysis.Regression
 
betaMinMaxPlot() - Method in class flanagan.analysis.Regression
 
betaMode(double, double) - Static method in class flanagan.analysis.Stat
 
betaMode(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
betaPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
betaPDF(double, double, double, double, double) - Static method in class flanagan.analysis.Stat
 
betaPlot() - Method in class flanagan.analysis.Regression
 
betaRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
betaRand(double, double, double, double, int) - Static method in class flanagan.analysis.Stat
 
betaRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
betaRand(double, double, double, double, int, long) - Static method in class flanagan.analysis.Stat
 
BetaRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Beta distribution.
BetaRandomVariable() - Constructor for class jhplot.math.num.random.BetaRandomVariable
Default constructor.
BetaRandomVariable(double, double) - Constructor for class jhplot.math.num.random.BetaRandomVariable
Create a random variable with the given alpha and beta values.
BetaRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.BetaRandomVariable
Create a random variable with the given parameters.
BetaRejectionLoglogisticGen - Class in umontreal.iro.lecuyer.randvar
Implements Beta random variate generators using the rejection method with log-logistic envelopes.
BetaRejectionLoglogisticGen(RandomStream, RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaRejectionLoglogisticGen
Creates a beta random variate generator with parameters α = alpha and β = beta over the interval (0, 1), using main stream s and auxiliary stream aux.
BetaRejectionLoglogisticGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaRejectionLoglogisticGen
Creates a beta random variate generator with parameters α = alpha and β = beta, over the interval (0, 1), using stream s.
BetaRejectionLoglogisticGen(RandomStream, RandomStream, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaRejectionLoglogisticGen
Creates a beta random variate generator with parameters α = alpha and β = beta over the interval (a, b), using main stream s and auxiliary stream aux.
BetaRejectionLoglogisticGen(RandomStream, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaRejectionLoglogisticGen
Creates a beta random variate generator with parameters α = alpha and β = beta, over the interval (a, b), using stream s.
BetaRejectionLoglogisticGen(RandomStream, RandomStream, BetaDist) - Constructor for class umontreal.iro.lecuyer.randvar.BetaRejectionLoglogisticGen
Creates a new generator for the distribution dist, using stream s and auxiliary stream aux.
BetaRejectionLoglogisticGen(RandomStream, BetaDist) - Constructor for class umontreal.iro.lecuyer.randvar.BetaRejectionLoglogisticGen
Same as BetaRejectionLoglogisticGen (s, s, dist).
betaStandardDeviation(double, double) - Static method in class flanagan.analysis.Stat
 
betaStandardDeviation(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
betaStandDev(double, double) - Static method in class flanagan.analysis.Stat
 
betaStandDev(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
BetaStratifiedRejectionGen - Class in umontreal.iro.lecuyer.randvar
This class implements Beta random variate generators using the stratified rejection/patchwork rejection method.
BetaStratifiedRejectionGen(RandomStream, RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaStratifiedRejectionGen
Creates a beta random variate generator with parameters α = alpha and β = beta, over the interval (0, 1), using main stream s and auxiliary stream aux.
BetaStratifiedRejectionGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaStratifiedRejectionGen
Creates a beta random variate generator with parameters α = alpha and β = beta, over the interval (0, 1), using stream s.
BetaStratifiedRejectionGen(RandomStream, RandomStream, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaStratifiedRejectionGen
Creates a beta random variate generator with parameters α = alpha and β = beta, over the interval (a, b), using main stream s and auxiliary stream aux.
BetaStratifiedRejectionGen(RandomStream, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaStratifiedRejectionGen
Creates a beta random variate generator with parameters α = alpha and β = beta, over the interval (a, b), using stream s.
BetaStratifiedRejectionGen(RandomStream, RandomStream, BetaDist) - Constructor for class umontreal.iro.lecuyer.randvar.BetaStratifiedRejectionGen
Creates a new generator for the distribution dist, using the given stream s and auxiliary stream aux.
BetaStratifiedRejectionGen(RandomStream, BetaDist) - Constructor for class umontreal.iro.lecuyer.randvar.BetaStratifiedRejectionGen
Same as BetaStratifiedRejectionGen(s, s, dist).
BetaSymmetricalBestGen - Class in umontreal.iro.lecuyer.randvar
This class implements symmetrical beta random variate generators using Devroye's one-liner method.
BetaSymmetricalBestGen(RandomStream, RandomStream, RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaSymmetricalBestGen
Creates a symmetrical beta random variate generator with parameter α = alpha, using stream s1 to generate U1, stream s2 to generate U2 and stream s3 to generate S, as given in equation.
BetaSymmetricalBestGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaSymmetricalBestGen
Creates a symmetrical beta random variate generator with parameter α = alpha, using only one stream s1 to generate U1, U2, and S as given in equation.
BetaSymmetricalBestGen(RandomStream, RandomStream, RandomStream, BetaSymmetricalDist) - Constructor for class umontreal.iro.lecuyer.randvar.BetaSymmetricalBestGen
Creates a new generator for the distribution dist, using stream s1 to generate U1, stream s2 to generate U2 and stream s3 to generate S as given in equation.
BetaSymmetricalBestGen(RandomStream, BetaSymmetricalDist) - Constructor for class umontreal.iro.lecuyer.randvar.BetaSymmetricalBestGen
Creates a new generator for the distribution dist, using only one stream s1.
BetaSymmetricalDist - Class in umontreal.iro.lecuyer.probdist
Specializes the class BetaDist to the case of a symmetrical beta distribution over the interval [0, 1], with shape parameters α = β.
BetaSymmetricalDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Constructs a BetaSymmetricalDist object with parameters α = β = alpha, over the unit interval (0, 1).
BetaSymmetricalDist(double, int) - Constructor for class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Same as BetaSymmetricalDist (alpha), but using approximations of roughly d decimal digits of precision when computing the distribution, complementary distribution, and inverse functions.
BetaSymmetricalGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators with the symmetrical beta distribution with shape parameters α = β, over the interval (0, 1).
BetaSymmetricalGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaSymmetricalGen
Creates a new symmetrical beta generator with parameters α = alpha, over the interval (0, 1), using stream s.
BetaSymmetricalGen(RandomStream, BetaSymmetricalDist) - Constructor for class umontreal.iro.lecuyer.randvar.BetaSymmetricalGen
Creates a new generator for the distribution dist, using stream s.
BetaSymmetricalPolarGen - Class in umontreal.iro.lecuyer.randvar
This class implements symmetrical beta random variate generators using Ulrich's polar method.
BetaSymmetricalPolarGen(RandomStream, RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaSymmetricalPolarGen
Creates a symmetrical beta random variate generator with parameter α = alpha, using stream s1 to generate x and stream s2 to generate y, as in above.
BetaSymmetricalPolarGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.BetaSymmetricalPolarGen
Creates a symmetrical beta random variate generator with parameter α = alpha, using stream s1 to generate x and y, as in above.
BetaSymmetricalPolarGen(RandomStream, RandomStream, BetaSymmetricalDist) - Constructor for class umontreal.iro.lecuyer.randvar.BetaSymmetricalPolarGen
Creates a new generator for the distribution dist, using stream s1 to generate x and stream s2 to generate y, as in above.
BetaSymmetricalPolarGen(RandomStream, BetaSymmetricalDist) - Constructor for class umontreal.iro.lecuyer.randvar.BetaSymmetricalPolarGen
Creates a new generator for the distribution dist, using only one stream s1.
between(double, double) - Static method in class cern.jet.math.Functions
Constructs a function that returns (from<=a && a<=to) ? 1 : 0.
between(int, int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns (from<=a && a<=to) ? 1 : 0.
between(double, double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns (from<=a && a<=to) ? 1 : 0.
between(float, float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns (from<=a && a<=to) ? 1 : 0.
between(int, int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns (from<=a && a<=to) ? 1 : 0.
between(long, long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns (from<=a && a<=to) ? 1 : 0.
BiCubicSpline - Class in flanagan.interpolation
 
BiCubicSpline(double[], double[], double[][]) - Constructor for class flanagan.interpolation.BiCubicSpline
 
BiCubicSpline(int, int) - Constructor for class flanagan.interpolation.BiCubicSpline
 
BiCubicSplineFast - Class in flanagan.interpolation
 
BiCubicSplineFast(double[], double[], double[][]) - Constructor for class flanagan.interpolation.BiCubicSplineFast
 
BiCubicSplineFirstDerivative - Class in flanagan.interpolation
 
BiCubicSplineFirstDerivative(double[], double[], double[][]) - Constructor for class flanagan.interpolation.BiCubicSplineFirstDerivative
 
BicubicSplineInterpolatingFunction - Class in org.apache.commons.math.analysis.interpolation
Function that implements the bicubic spline interpolation.
BicubicSplineInterpolatingFunction(double[], double[], double[][], double[][], double[][], double[][]) - Constructor for class org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolatingFunction
 
BicubicSplineInterpolator - Class in org.apache.commons.math.analysis.interpolation
Generates a bicubic interpolating function.
BicubicSplineInterpolator() - Constructor for class org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolator
 
BiCubicSplinePartialDerivative - Class in flanagan.interpolation
 
BiCubicSplinePartialDerivative(double[], double[], double[][]) - Constructor for class flanagan.interpolation.BiCubicSplinePartialDerivative
 
BiCubicSplineShort - Class in flanagan.interpolation
 
BiCubicSplineShort(double[], double[], double[][]) - Constructor for class flanagan.interpolation.BiCubicSplineShort
 
BIG_ENDIAN - Static variable in class jhplot.math.io.BinaryFile
 
BIG_ENDIAN - Static variable in class jhplot.math.io.BinaryInputStream
 
BIG_ENDIAN - Static variable in class jhplot.math.io.BinaryOutputStream
 
bigDecimalValue() - Method in class org.apache.commons.math.fraction.BigFraction
Gets the fraction as a BigDecimal.
bigDecimalValue(int) - Method in class org.apache.commons.math.fraction.BigFraction
Gets the fraction as a BigDecimal following the passed rounding mode.
bigDecimalValue(int, int) - Method in class org.apache.commons.math.fraction.BigFraction
Gets the fraction as a BigDecimal following the passed scale and rounding mode.
bigDecimalValue() - Method in class org.apache.commons.math.util.BigReal
Get the BigDecimal value corresponding to the instance.
BigFraction - Class in org.apache.commons.math.fraction
Representation of a rational number without any overflow.
BigFraction(BigInteger) - Constructor for class org.apache.commons.math.fraction.BigFraction
Create a BigFraction equivalent to the passed BigInteger, ie "num / 1".
BigFraction(BigInteger, BigInteger) - Constructor for class org.apache.commons.math.fraction.BigFraction
Create a BigFraction given the numerator and denominator as BigInteger.
BigFraction(double) - Constructor for class org.apache.commons.math.fraction.BigFraction
Create a fraction given the double value.
BigFraction(double, double, int) - Constructor for class org.apache.commons.math.fraction.BigFraction
Create a fraction given the double value and maximum error allowed.
BigFraction(double, int) - Constructor for class org.apache.commons.math.fraction.BigFraction
Create a fraction given the double value and maximum denominator.
BigFraction(int) - Constructor for class org.apache.commons.math.fraction.BigFraction
Create a BigFraction equivalent to the passed int, ie "num / 1".
BigFraction(int, int) - Constructor for class org.apache.commons.math.fraction.BigFraction
Create a BigFraction given the numerator and denominator as simple int.
BigFraction(long) - Constructor for class org.apache.commons.math.fraction.BigFraction
Create a BigFraction equivalent to the passed long, ie "num / 1".
BigFraction(long, long) - Constructor for class org.apache.commons.math.fraction.BigFraction
Create a BigFraction given the numerator and denominator as simple long.
BigFractionField - Class in org.apache.commons.math.fraction
Representation of the fractional numbers without any overflow field.
BigFractionFormat - Class in org.apache.commons.math.fraction
Formats a BigFraction number in proper format or improper format.
BigFractionFormat() - Constructor for class org.apache.commons.math.fraction.BigFractionFormat
Create an improper formatting instance with the default number format for the numerator and denominator.
BigFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math.fraction.BigFractionFormat
Create an improper formatting instance with a custom number format for both the numerator and denominator.
BigFractionFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math.fraction.BigFractionFormat
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
bigFractionMatrixToRealMatrix(FieldMatrix<BigFraction>) - Static method in class org.apache.commons.math.linear.MatrixUtils
Convert a FieldMatrix/BigFraction matrix to a RealMatrix.
BigMatrix - Interface in org.apache.commons.math.linear
Deprecated. as of 2.0, replaced by FieldMatrix with a BigReal parameter
BigMatrixImpl - Class in org.apache.commons.math.linear
Deprecated. as of 2.0, replaced by Array2DRowFieldMatrix with a BigReal parameter
BigMatrixImpl() - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Creates a matrix with no data
BigMatrixImpl(int, int) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Create a new BigMatrix with the supplied row and column dimensions.
BigMatrixImpl(BigDecimal[][]) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Create a new BigMatrix using d as the underlying data array.
BigMatrixImpl(BigDecimal[][], boolean) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Create a new BigMatrix using the input array as the underlying data array.
BigMatrixImpl(double[][]) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Create a new BigMatrix using d as the underlying data array.
BigMatrixImpl(String[][]) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Create a new BigMatrix using the values represented by the strings in d as the underlying data array.
BigMatrixImpl(BigDecimal[]) - Constructor for class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Create a new (column) BigMatrix using v as the data for the unique column of the v.length x 1 matrix created.
BigReal - Class in org.apache.commons.math.util
Arbitrary precision decimal number.
BigReal(BigDecimal) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a BigDecimal.
BigReal(BigInteger) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a BigInteger.
BigReal(BigInteger, int) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from an unscaled BigInteger.
BigReal(BigInteger, int, MathContext) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from an unscaled BigInteger.
BigReal(BigInteger, MathContext) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a BigInteger.
BigReal(char[]) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a characters representation.
BigReal(char[], int, int) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a characters representation.
BigReal(char[], int, int, MathContext) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a characters representation.
BigReal(char[], MathContext) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a characters representation.
BigReal(double) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a double.
BigReal(double, MathContext) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a double.
BigReal(int) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from an int.
BigReal(int, MathContext) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from an int.
BigReal(long) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a long.
BigReal(long, MathContext) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a long.
BigReal(String) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a String representation.
BigReal(String, MathContext) - Constructor for class org.apache.commons.math.util.BigReal
Build an instance from a String representation.
BigRealField - Class in org.apache.commons.math.util
Representation of real numbers with arbitrary precision field.
bin(DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Fills all cell values of the given vector into a bin from which statistics measures can be retrieved efficiently.
bin(DoubleMatrix1D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Fills all cell values of the given vector into a bin from which statistics measures can be retrieved efficiently.
bin(FloatMatrix1D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Fills all cell values of the given vector into a bin from which statistics measures can be retrieved efficiently.
Bin - Class in umontreal.iro.lecuyer.simprocs
A Bin corresponds to a pile of identical tokens, and a list of processes waiting for the tokens when the list is empty.
Bin() - Constructor for class umontreal.iro.lecuyer.simprocs.Bin
Constructs a new bin, initially empty, with service policy FIFO and linked with the default simulator.
Bin(ProcessSimulator) - Constructor for class umontreal.iro.lecuyer.simprocs.Bin
Constructs a new bin, initially empty, with service policy FIFO and linked with simulator sim.
Bin(String) - Constructor for class umontreal.iro.lecuyer.simprocs.Bin
Constructs a new bin, initially empty, with service policy FIFO, identifier name and linked with the default simulator.
Bin(ProcessSimulator, String) - Constructor for class umontreal.iro.lecuyer.simprocs.Bin
Constructs a new bin, initially empty, with service policy FIFO, identifier name and linked with simulator sim.
BinaryChromosome - Class in org.apache.commons.math.genetics
Chromosome represented by a vector of 0s and 1s.
BinaryChromosome(List<Integer>) - Constructor for class org.apache.commons.math.genetics.BinaryChromosome
Constructor.
BinaryChromosome(Integer[]) - Constructor for class org.apache.commons.math.genetics.BinaryChromosome
Constructor.
BinaryFile - Class in jhplot.math.io
BSD License
BinaryFile(File, String) - Constructor for class jhplot.math.io.BinaryFile
 
BinaryFunction - Class in org.apache.commons.math.analysis
Deprecated. in 2.2
BinaryFunction() - Constructor for class org.apache.commons.math.analysis.BinaryFunction
Deprecated.  
BinaryInputStream - Class in jhplot.math.io
BSD License
BinaryInputStream(InputStream, String) - Constructor for class jhplot.math.io.BinaryInputStream
 
BinaryInputStream(InputStream, boolean) - Constructor for class jhplot.math.io.BinaryInputStream
 
BinaryMutation - Class in org.apache.commons.math.genetics
Mutation for BinaryChromosomes.
BinaryMutation() - Constructor for class org.apache.commons.math.genetics.BinaryMutation
 
BinaryOutputStream - Class in jhplot.math.io
BSD License
BinaryOutputStream(OutputStream, String) - Constructor for class jhplot.math.io.BinaryOutputStream
 
BinaryOutputStream(OutputStream, boolean) - Constructor for class jhplot.math.io.BinaryOutputStream
 
binarySearch(boolean) - Method in class cern.colt.list.AbstractBooleanList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(byte) - Method in class cern.colt.list.AbstractByteList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(char) - Method in class cern.colt.list.AbstractCharList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(double) - Method in class cern.colt.list.AbstractDoubleList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(float) - Method in class cern.colt.list.AbstractFloatList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(int) - Method in class cern.colt.list.AbstractIntList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(long) - Method in class cern.colt.list.AbstractLongList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(short) - Method in class cern.colt.list.AbstractShortList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(Object) - Method in class cern.colt.list.ObjectArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(boolean) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(byte) - Method in class cern.colt.list.tbyte.AbstractByteList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(char) - Method in class cern.colt.list.tchar.AbstractCharList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(double) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(float) - Method in class cern.colt.list.tfloat.AbstractFloatList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(int) - Method in class cern.colt.list.tint.AbstractIntList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(long) - Method in class cern.colt.list.tlong.AbstractLongList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(Object) - Method in class cern.colt.list.tobject.ObjectArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearch(short) - Method in class cern.colt.list.tshort.AbstractShortList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(boolean, int, int) - Method in class cern.colt.list.AbstractBooleanList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(byte, int, int) - Method in class cern.colt.list.AbstractByteList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(char, int, int) - Method in class cern.colt.list.AbstractCharList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(double, int, int) - Method in class cern.colt.list.AbstractDoubleList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(float, int, int) - Method in class cern.colt.list.AbstractFloatList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(int, int, int) - Method in class cern.colt.list.AbstractIntList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(long, int, int) - Method in class cern.colt.list.AbstractLongList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(short, int, int) - Method in class cern.colt.list.AbstractShortList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(byte, int, int) - Method in class cern.colt.list.ByteArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(char, int, int) - Method in class cern.colt.list.CharArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(double, int, int) - Method in class cern.colt.list.DoubleArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(float, int, int) - Method in class cern.colt.list.FloatArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(int, int, int) - Method in class cern.colt.list.IntArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(long, int, int) - Method in class cern.colt.list.LongArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(Object, int, int) - Method in class cern.colt.list.ObjectArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(Object, int, int, Comparator) - Method in class cern.colt.list.ObjectArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(short, int, int) - Method in class cern.colt.list.ShortArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(boolean, int, int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(byte, int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(byte, int, int) - Method in class cern.colt.list.tbyte.ByteArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(char, int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(char, int, int) - Method in class cern.colt.list.tchar.CharArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(double, int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(double, int, int) - Method in class cern.colt.list.tdouble.DoubleArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(float, int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(float, int, int) - Method in class cern.colt.list.tfloat.FloatArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(int, int, int) - Method in class cern.colt.list.tint.AbstractIntList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(int, int, int) - Method in class cern.colt.list.tint.IntArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(long, int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(long, int, int) - Method in class cern.colt.list.tlong.LongArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(Object, int, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(Object, int, int, Comparator) - Method in class cern.colt.list.tobject.ObjectArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(short, int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(short, int, int) - Method in class cern.colt.list.tshort.ShortArrayList
Searches the receiver for the specified value using the binary search algorithm.
binarySearchFromTo(byte[], byte, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(char[], char, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(double[], double, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(float[], float, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(int[], int, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(long[], long, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(Object[], Object, int, int, Comparator) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(short[], short, int, int) - Static method in class cern.colt.Sorting
Searches the list for the specified value using the binary search algorithm.
binarySearchFromTo(int, int, IntComparator) - Static method in class cern.colt.Sorting
Generically searches the list for the specified value using the binary search algorithm.
binaryShannonEntropy(double) - Static method in class flanagan.analysis.Stat
 
binaryShannonEntropyBit(double) - Static method in class flanagan.analysis.Stat
 
binaryShannonEntropyDit(double) - Static method in class flanagan.analysis.Stat
 
binaryShannonEntropyNat(double) - Static method in class flanagan.analysis.Stat
 
BinaryTree - Class in umontreal.iro.lecuyer.simevents.eventlist
An implementation of EventList using a binary search tree.
BinaryTree() - Constructor for class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
BinBinFunction1D - Interface in cern.hep.aida.bin
Interface that represents a function object: a function that takes two bins as arguments and returns a single value.
binCenter(int) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
binCenter(int) - Method in interface hep.aida.ref.histogram.binner.Binner1D
This method can be used to improve accuracy of the bin RMB and MEAN calculations.
binCenter(int) - Method in class hep.aida.ref.histogram.FixedAxis
 
binCenter(int) - Method in class hep.aida.ref.histogram.VariableAxis
 
binCenter(int) - Method in class jhplot.H1D
Get bin centres.
binCenter(int) - Method in class jhplot.HProf1D
Get bin centres.
binCenters() - Method in class jhplot.H1D
Get all bin centers in form of array
binCenters() - Method in class jhplot.HProf1D
Get all bin centers in form of array
binCentre(int) - Method in class cern.hep.aida.ref.FixedAxis
 
binCentre(int) - Method in class cern.hep.aida.ref.VariableAxis
 
binCentre(int) - Method in interface hep.aida.tdouble.DoubleIAxis
Centre of the bin specified.
binCentre(int) - Method in class hep.aida.tdouble.ref.DoubleFixedAxis
 
binCentre(int) - Method in class hep.aida.tdouble.ref.DoubleVariableAxis
 
binCentre(int) - Method in interface hep.aida.tfloat.FloatIAxis
Centre of the bin specified.
binCentre(int) - Method in class hep.aida.tfloat.ref.FloatFixedAxis
 
binCentre(int) - Method in class hep.aida.tfloat.ref.FloatVariableAxis
 
bindArg1(DoubleDoubleFunction, double) - Static method in class cern.jet.math.Functions
Constructs a unary function from a binary function with the first operand (argument) fixed to the given constant c.
bindArg1(IntIntFunction, int) - Static method in class cern.jet.math.IntFunctions
Constructs a unary function from a binary function with the first operand (argument) fixed to the given constant c.
bindArg1(DComplexDComplexDComplexFunction, double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
bindArg1(DoubleDoubleFunction, double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a unary function from a binary function with the first operand (argument) fixed to the given constant c.
bindArg1(FComplexFComplexFComplexFunction, float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
bindArg1(FloatFloatFunction, float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a unary function from a binary function with the first operand (argument) fixed to the given constant c.
bindArg1(IntIntFunction, int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a unary function from a binary function with the first operand (argument) fixed to the given constant c.
bindArg1(LongLongFunction, long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a unary function from a binary function with the first operand (argument) fixed to the given constant c.
bindArg2(DoubleDoubleFunction, double) - Static method in class cern.jet.math.Functions
Constructs a unary function from a binary function with the second operand (argument) fixed to the given constant c.
bindArg2(IntIntFunction, int) - Static method in class cern.jet.math.IntFunctions
Constructs a unary function from a binary function with the second operand (argument) fixed to the given constant c.
bindArg2(DComplexDComplexDComplexFunction, double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
bindArg2(DoubleDoubleFunction, double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a unary function from a binary function with the second operand (argument) fixed to the given constant c.
bindArg2(FComplexFComplexFComplexFunction, float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
bindArg2(FloatFloatFunction, float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a unary function from a binary function with the second operand (argument) fixed to the given constant c.
bindArg2(IntIntFunction, int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a unary function from a binary function with the second operand (argument) fixed to the given constant c.
bindArg2(LongLongFunction, long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a unary function from a binary function with the second operand (argument) fixed to the given constant c.
binEntries(int) - Method in class cern.hep.aida.ref.Histogram1D
 
binEntries(int, int) - Method in class cern.hep.aida.ref.Histogram2D
 
binEntries(int, int, int) - Method in class cern.hep.aida.ref.Histogram3D
 
binEntries(int) - Method in class hep.aida.ref.histogram.Histogram1D
Number of entries in the corresponding bin (ie the number of times fill was called for this bin).
binEntries(int, int) - Method in class hep.aida.ref.histogram.Histogram2D
Number of entries in the corresponding bin (ie the number of times fill was called for this bin).
binEntries(int, int, int) - Method in class hep.aida.ref.histogram.Histogram3D
Number of entries in the corresponding bin (ie the number of times fill was called for this bin).
binEntries(int) - Method in class hep.aida.ref.histogram.Profile1D
 
binEntries(int, int) - Method in class hep.aida.ref.histogram.Profile2D
 
binEntries(int) - Method in interface hep.aida.tdouble.DoubleIHistogram1D
Number of entries in the corresponding bin (ie the number of times fill was called for this bin).
binEntries(int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
The number of entries (ie the number of times fill was called for this bin).
binEntries(int, int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
The number of entries (ie the number of times fill was called for this bin).
binEntries(int) - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
binEntries(int, int) - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
binEntries(int, int, int) - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
binEntries(int) - Method in interface hep.aida.tfloat.FloatIHistogram1D
Number of entries in the corresponding bin (ie the number of times fill was called for this bin).
binEntries(int, int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
The number of entries (ie the number of times fill was called for this bin).
binEntries(int, int, int) - Method in interface hep.aida.tfloat.FloatIHistogram3D
The number of entries (ie the number of times fill was called for this bin).
binEntries(int) - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
binEntries(int, int) - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
binEntries(int, int, int) - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
binEntries(int) - Method in class jhplot.H1D
Number of entries in a bin with index i
binEntries() - Method in class jhplot.H1D
Get all entries of the histogram as an array
binEntries(int, int) - Method in class jhplot.H2D
Number of entries in the corresponding bin (i.e.
binEntries(int) - Method in class jhplot.HProf1D
Number of entries in a bin with index i
binEntries() - Method in class jhplot.HProf1D
Get all entries of the histogram as an array
binEntries(int, int) - Method in class jhplot.HProf2D
Number of entries in the corresponding bin (i.e.
binEntriesX(int) - Method in class hep.aida.ref.histogram.Histogram2D
Number of entries with a given x bin number (ie the number of times fill was called for these bins).
binEntriesX(int) - Method in class hep.aida.ref.histogram.Histogram3D
Number of entries with a given x bin number (ie the number of times fill was called for these bins).
binEntriesX(int) - Method in class hep.aida.ref.histogram.Profile2D
 
binEntriesX(int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Equivalent to projectionX().binEntries(indexX).
binEntriesX(int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Equivalent to projectionX().binEntries(indexX).
binEntriesY(int) - Method in class hep.aida.ref.histogram.Histogram2D
Number of entries with a given y bin number (ie the number of times fill was called for these bins).
binEntriesY(int) - Method in class hep.aida.ref.histogram.Histogram3D
Number of entries with a given x bin number (ie the number of times fill was called for these bins).
binEntriesY(int) - Method in class hep.aida.ref.histogram.Profile2D
 
binEntriesY(int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Equivalent to projectionY().binEntries(indexY).
binEntriesY(int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Equivalent to projectionY().binEntries(indexY).
binEntriesZ(int) - Method in class hep.aida.ref.histogram.Histogram3D
Number of entries with a given x bin number (ie the number of times fill was called for these bins).
binError(int) - Method in class cern.hep.aida.ref.Histogram1D
 
binError(int, int) - Method in class cern.hep.aida.ref.Histogram2D
 
binError(int, int, int) - Method in class cern.hep.aida.ref.Histogram3D
 
BinError - Interface in hep.aida.ref.dataset.binner
Classes implementing this interfaces calculate the plus and minus error on a bin given its entries and height.
binError(int) - Method in class hep.aida.ref.histogram.Histogram1D
The error on this bin.
binError(int, int) - Method in class hep.aida.ref.histogram.Histogram2D
The error on this bin.
binError(int, int, int) - Method in class hep.aida.ref.histogram.Histogram3D
The error on this bin.
binError(int) - Method in class hep.aida.ref.histogram.Profile1D
 
binError(int, int) - Method in class hep.aida.ref.histogram.Profile2D
 
binError(int) - Method in interface hep.aida.tdouble.DoubleIHistogram1D
The error on this bin.
binError(int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
The error on this bin.
binError(int, int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
The error on this bin.
binError(int) - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
binError(int, int) - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
binError(int, int, int) - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
binError(int) - Method in interface hep.aida.tfloat.FloatIHistogram1D
The error on this bin.
binError(int, int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
The error on this bin.
binError(int, int, int) - Method in interface hep.aida.tfloat.FloatIHistogram3D
The error on this bin.
binError(int) - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
binError(int, int) - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
binError(int, int, int) - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
binError(int) - Method in class jhplot.H1D
Error on the bin with index i
binError(int, int) - Method in class jhplot.H2D
Error of the corresponding bin.
binError(int) - Method in class jhplot.HProf1D
Error on the bin with index i
binError(int, int) - Method in class jhplot.HProf2D
Error of the corresponding bin.
binErrors() - Method in class jhplot.H1D
Get all bin errors of the histogram as an array
binErrors() - Method in class jhplot.HProf1D
Get all bin errors of the histogram as an array
BinFunction1D - Interface in cern.hep.aida.bin
Interface that represents a function object: a function that takes two bins as arguments and returns a single value.
BinFunctions1D - Class in cern.hep.aida.bin
Function objects computing dynamic bin aggregations; to be passed to generic methods.
binHeight(int) - Method in class cern.hep.aida.ref.Histogram1D
 
binHeight(int, int) - Method in class cern.hep.aida.ref.Histogram2D
 
binHeight(int, int, int) - Method in class cern.hep.aida.ref.Histogram3D
 
binHeight(int) - Method in class hep.aida.ref.histogram.Histogram1D
Total height of the corresponding bin.
binHeight(int, int) - Method in class hep.aida.ref.histogram.Histogram2D
Total height of the corresponding bin.
binHeight(int, int, int) - Method in class hep.aida.ref.histogram.Histogram3D
Total height of the corresponding bin.
binHeight(int) - Method in class hep.aida.ref.histogram.Profile1D
 
binHeight(int, int) - Method in class hep.aida.ref.histogram.Profile2D
 
binHeight(int) - Method in interface hep.aida.tdouble.DoubleIHistogram1D
Total height of the corresponding bin (ie the sum of the weights in this bin).
binHeight(int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Total height of the corresponding bin (ie the sum of the weights in this bin).
binHeight(int, int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Total height of the corresponding bin (ie the sum of the weights in this bin).
binHeight(int) - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
binHeight(int, int) - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
binHeight(int, int, int) - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
binHeight(int) - Method in interface hep.aida.tfloat.FloatIHistogram1D
Total height of the corresponding bin (ie the sum of the weights in this bin).
binHeight(int, int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Total height of the corresponding bin (ie the sum of the weights in this bin).
binHeight(int, int, int) - Method in interface hep.aida.tfloat.FloatIHistogram3D
Total height of the corresponding bin (ie the sum of the weights in this bin).
binHeight(int) - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
binHeight(int, int) - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
binHeight(int, int, int) - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
binHeight(int) - Method in class jhplot.H1D
Height of the corresponding bin
binHeight(int, int) - Method in class jhplot.H2D
Total height of the corresponding bin.
binHeight(int) - Method in class jhplot.HProf1D
Height of the corresponding bin
binHeight(int, int) - Method in class jhplot.HProf2D
Total height of the corresponding bin.
binHeights() - Method in class jhplot.H1D
Get all heights of the histogram as an array
binHeights() - Method in class jhplot.HProf1D
Get all heights of the histogram as an array
binHeightX(int) - Method in class hep.aida.ref.histogram.Histogram2D
Total height of the corresponding x bin along y.
binHeightX(int) - Method in class hep.aida.ref.histogram.Histogram3D
Total height of the corresponding x bin along y and z.
binHeightX(int) - Method in class hep.aida.ref.histogram.Profile2D
 
binHeightX(int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Equivalent to projectionX().binHeight(indexX).
binHeightX(int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Equivalent to projectionX().binHeight(indexX).
binHeightY(int) - Method in class hep.aida.ref.histogram.Histogram2D
Total height of the corresponding y bin along x.
binHeightY(int) - Method in class hep.aida.ref.histogram.Histogram3D
Total height of the corresponding y bin along x and z.
binHeightY(int) - Method in class hep.aida.ref.histogram.Profile2D
 
binHeightY(int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Equivalent to projectionY().binHeight(indexY).
binHeightY(int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Equivalent to projectionY().binHeight(indexY).
binHeightZ(int) - Method in class hep.aida.ref.histogram.Histogram3D
Total height of the corresponding z bin along x and y.
binLowerEdge(int) - Method in class cern.hep.aida.ref.FixedAxis
 
binLowerEdge(int) - Method in class cern.hep.aida.ref.VariableAxis
 
binLowerEdge(int) - Method in class hep.aida.ref.histogram.FixedAxis
Get the lower edge of a bin.
binLowerEdge(int) - Method in class hep.aida.ref.histogram.VariableAxis
 
binLowerEdge(int) - Method in interface hep.aida.tdouble.DoubleIAxis
Lower edge of the specified bin.
binLowerEdge(int) - Method in class hep.aida.tdouble.ref.DoubleFixedAxis
 
binLowerEdge(int) - Method in class hep.aida.tdouble.ref.DoubleVariableAxis
 
binLowerEdge(int) - Method in interface hep.aida.tfloat.FloatIAxis
Lower edge of the specified bin.
binLowerEdge(int) - Method in class hep.aida.tfloat.ref.FloatFixedAxis
 
binLowerEdge(int) - Method in class hep.aida.tfloat.ref.FloatVariableAxis
 
binLowerEdge(int) - Method in class jhplot.H1D
Get bin lower edge.
binLowerEdge(int) - Method in class jhplot.HProf1D
Get bin lower edge.
binLowerEdges() - Method in class jhplot.H1D
Get all lower edges in form of array
binLowerEdges() - Method in class jhplot.HProf1D
Get all lower edges in form of array
binMean(int) - Method in class hep.aida.ref.histogram.Histogram1D
Get the mean of a bin.
binMean(int) - Method in class hep.aida.ref.histogram.Profile1D
 
binMean(int) - Method in class jhplot.H1D
Mean in a single bin with index
binMean(int) - Method in class jhplot.HProf1D
Mean in a single bin with index
binMeanX(int, int) - Method in class hep.aida.ref.histogram.Histogram2D
Get the mean of a bin along the x axis.
binMeanX(int, int, int) - Method in class hep.aida.ref.histogram.Histogram3D
Get the mean of a bin along the x axis.
binMeanX(int, int) - Method in class hep.aida.ref.histogram.Profile2D
 
binMeanY(int, int) - Method in class hep.aida.ref.histogram.Histogram2D
Get the mean of a bin along the y axis.
binMeanY(int, int, int) - Method in class hep.aida.ref.histogram.Histogram3D
Get the mean of a bin along the y axis.
binMeanY(int, int) - Method in class hep.aida.ref.histogram.Profile2D
 
binMeanZ(int, int, int) - Method in class hep.aida.ref.histogram.Histogram3D
Get the mean of a bin along the z axis.
BinnedMaximumLikelihoodFitMethod - Class in hep.aida.ref.fitter.fitmethod
 
BinnedMaximumLikelihoodFitMethod() - Constructor for class hep.aida.ref.fitter.fitmethod.BinnedMaximumLikelihoodFitMethod
 
Binner - Interface in hep.aida.ref.dataset.binner
A binner is responsible to keep track of the bins statistics for a binned data container in n-dimensions.
binner() - Method in class hep.aida.ref.histogram.Histogram1D
 
Binner1D - Interface in hep.aida.ref.histogram.binner
 
Binner2D - Interface in hep.aida.ref.histogram.binner
 
Binner3D - Interface in hep.aida.ref.histogram.binner
 
BinnerMath - Class in hep.aida.ref.histogram.binner
 
BinnerMath() - Constructor for class hep.aida.ref.histogram.binner.BinnerMath
 
binOfElement(float) - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns the bin index of the given element.
binOfElement(double) - Method in class cern.jet.stat.tdouble.quantile.DoubleEquiDepthHistogram
Returns the bin index of the given element.
binOfElement(float) - Method in class cern.jet.stat.tfloat.quantile.FloatEquiDepthHistogram
Returns the bin index of the given element.
binomial(double, long) - Static method in class cern.jet.math.Arithmetic
Efficiently returns the binomial coefficient, often also referred to as "n over k" or "n choose k".
binomial(long, long) - Static method in class cern.jet.math.Arithmetic
Efficiently returns the binomial coefficient, often also referred to as "n over k" or "n choose k".
binomial(double, long) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Efficiently returns the binomial coefficient, often also referred to as "n over k" or "n choose k".
binomial(long, long) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Efficiently returns the binomial coefficient, often also referred to as "n over k" or "n choose k".
binomial(float, long) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Efficiently returns the binomial coefficient, often also referred to as "n over k" or "n choose k".
binomial(long, long) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Efficiently returns the binomial coefficient, often also referred to as "n over k" or "n choose k".
Binomial - Class in cern.jet.random
Binomial distribution; See the math definition and animated definition.
Binomial(int, double, RandomEngine) - Constructor for class cern.jet.random.Binomial
Constructs a binomial distribution.
Binomial - Class in cern.jet.random.tdouble
Binomial distribution; See the math definition and animated definition.
Binomial(int, double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.Binomial
Constructs a binomial distribution.
binomial(int, int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the terms 0 through k of the Binomial probability density.
binomial(int, int, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the sum of the terms 0 through k of the Binomial probability density.
binomial(double, int, int) - Static method in class flanagan.analysis.Stat
 
Binomial - Class in jhplot.math.num.pdf
The Binomial distribution.
Binomial() - Constructor for class jhplot.math.num.pdf.Binomial
Default constructor.
Binomial(int, double) - Constructor for class jhplot.math.num.pdf.Binomial
Create a distribution with the given number of trials and probability of success.
binomialArray(double, int, int) - Method in class flanagan.math.PsRandom
 
binomialCDF(double, int, int) - Static method in class flanagan.analysis.Stat
 
binomialCoeff(int, int) - Static method in class flanagan.analysis.Stat
 
binomialCoefficient(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns an exact representation of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficientDouble(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns a double representation of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialCoefficientLog(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns the natural log of the Binomial Coefficient, "n choose k", the number of k-element subsets that can be selected from an n-element set.
binomialComplemented(int, int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the terms k+1 through n of the Binomial probability density.
binomialComplemented(int, int, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the sum of the terms k+1 through n of the Binomial probability density.
BinomialConvolutionGen - Class in umontreal.iro.lecuyer.randvar
Implements binomial random variate generators using the convolution method.
BinomialConvolutionGen(RandomStream, int, double) - Constructor for class umontreal.iro.lecuyer.randvar.BinomialConvolutionGen
Creates a binomial random variate generator with parameters n and p, using stream s.
BinomialConvolutionGen(RandomStream, BinomialDist) - Constructor for class umontreal.iro.lecuyer.randvar.BinomialConvolutionGen
Creates a random variate generator for the binomial distribution dist and stream s.
BinomialDist - Class in umontreal.iro.lecuyer.probdist
Extends the class DiscreteDistributionInt for the binomial distribution with parameters n and p, where n is a positive integer and 0 <= p <= 1.
BinomialDist(int, double) - Constructor for class umontreal.iro.lecuyer.probdist.BinomialDist
Creates an object that contains the binomial terms, for 0 <= x <= n, and the corresponding cumulative function.
BinomialDistribution - Interface in org.apache.commons.math.distribution
The Binomial Distribution.
BinomialDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of BinomialDistribution.
BinomialDistributionImpl(int, double) - Constructor for class org.apache.commons.math.distribution.BinomialDistributionImpl
Create a binomial distribution with the given number of trials and probability of success.
BinomialGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the binomial distribution.
BinomialGen(RandomStream, int, double) - Constructor for class umontreal.iro.lecuyer.randvar.BinomialGen
Creates a binomial random variate generator with parameters n and p, using stream s.
BinomialGen(RandomStream, BinomialDist) - Constructor for class umontreal.iro.lecuyer.randvar.BinomialGen
Creates a random variate generator for the binomial distribution dist and the random stream s.
binomialPDF(double, int, int) - Static method in class flanagan.analysis.Stat
 
binomialProb(double, int, int) - Static method in class flanagan.analysis.Stat
 
binomialRand(double, int, int) - Method in class flanagan.analysis.Stat
 
binomialRand(double, int, int, long) - Method in class flanagan.analysis.Stat
 
BinomialRandomVariable - Class in jhplot.math.num.random
 
BinomialRandomVariable() - Constructor for class jhplot.math.num.random.BinomialRandomVariable
Default constructor.
BinomialRandomVariable(int, double) - Constructor for class jhplot.math.num.random.BinomialRandomVariable
Create a random variable with the given number of trials and probability of success.
BinomialRandomVariable(int, double, RNG) - Constructor for class jhplot.math.num.random.BinomialRandomVariable
Create a random variable with the given parameters.
BiNormalDist - Class in umontreal.iro.lecuyer.probdistmulti
Extends the class ContinuousDistribution2Dim for the bivariate normal distribution.
BiNormalDist(double) - Constructor for class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Constructs a BiNormalDist object with default parameters μ1 = μ2 = 0, σ1 = σ2 = 1 and correlation ρ = rho.
BiNormalDist(double, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Constructs a BiNormalDist object with parameters μ1 = mu1, μ2 = mu2, σ1 = sigma1, σ2 = sigma2 and ρ = rho.
BiNormalDonnellyDist - Class in umontreal.iro.lecuyer.probdistmulti
Extends the class BiNormalDist for the bivariate normal distribution using a translation of Donnelly's FORTRAN code.
BiNormalDonnellyDist(double, int) - Constructor for class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
Constructor with default parameters μ1 = μ2 = 0, σ1 = σ2 = 1, correlation ρ = rho, and d = ndig digits of accuracy (the absolute error is smaller than 10-d).
BiNormalDonnellyDist(double) - Constructor for class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
Same as BiNormalDonnellyDist (rho, 15).
BiNormalDonnellyDist(double, double, double, double, double, int) - Constructor for class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
Constructor with parameters μ1 = mu1, μ2 = mu2, σ1 = sigma1, σ2 = sigma2, ρ = rho, and d = ndig digits of accuracy.
BiNormalDonnellyDist(double, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
Same as BiNormalDonnellyDist (mu1, sigma1, mu2, sigma2, rho, 15).
BiNormalGenzDist - Class in umontreal.iro.lecuyer.probdistmulti
Extends the class BiNormalDist for the bivariate normal distribution using Genz's algorithm as described in.
BiNormalGenzDist(double) - Constructor for class umontreal.iro.lecuyer.probdistmulti.BiNormalGenzDist
Constructs a BiNormalGenzDist object with default parameters μ1 = μ2 = 0, σ1 = σ2 = 1 and correlation ρ = rho.
BiNormalGenzDist(double, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.probdistmulti.BiNormalGenzDist
Constructs a BiNormalGenzDist object with parameters μ1 = mu1, μ2 = mu2, σ1 = sigma1, σ2 = sigma2 and ρ = rho.
binRms(int) - Method in class hep.aida.ref.histogram.Histogram1D
Get the RMS of a bin.
binRms(int) - Method in class hep.aida.ref.histogram.Profile1D
 
binRms(int, int) - Method in class hep.aida.ref.histogram.Profile2D
 
binRms(int) - Method in class jhplot.H1D
RMS of a single bin with index
binRms(int) - Method in class jhplot.HProf1D
RMS of a single bin with index
binRmsX(int, int) - Method in class hep.aida.ref.histogram.Histogram2D
Get the RMS of a bin along the x axis.
binRmsX(int, int, int) - Method in class hep.aida.ref.histogram.Histogram3D
Get the RMS of a bin along the x axis.
binRmsY(int, int) - Method in class hep.aida.ref.histogram.Histogram2D
Get the RMS of a bin along the y axis.
binRmsY(int, int, int) - Method in class hep.aida.ref.histogram.Histogram3D
Get the RMS of a bin along the y axis.
binRmsZ(int, int, int) - Method in class hep.aida.ref.histogram.Histogram3D
Get the RMS of a bin along the z axis.
bins() - Method in class cern.hep.aida.ref.FixedAxis
 
bins() - Method in class cern.hep.aida.ref.VariableAxis
 
bins() - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns the number of bins.
bins() - Method in class cern.jet.stat.tdouble.quantile.DoubleEquiDepthHistogram
Returns the number of bins.
bins() - Method in class cern.jet.stat.tfloat.quantile.FloatEquiDepthHistogram
Returns the number of bins.
bins() - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
bins() - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
bins() - Method in class hep.aida.ref.histogram.FixedAxis
Get the number of bins in the Axis.
bins() - Method in class hep.aida.ref.histogram.VariableAxis
 
bins() - Method in interface hep.aida.tdouble.DoubleIAxis
The number of bins (excluding underflow and overflow) on the axis.
bins() - Method in class hep.aida.tdouble.ref.DoubleFixedAxis
 
bins() - Method in class hep.aida.tdouble.ref.DoubleVariableAxis
 
bins() - Method in interface hep.aida.tfloat.FloatIAxis
The number of bins (excluding underflow and overflow) on the axis.
bins() - Method in class hep.aida.tfloat.ref.FloatFixedAxis
 
bins() - Method in class hep.aida.tfloat.ref.FloatVariableAxis
 
binUpperEdge(int) - Method in class cern.hep.aida.ref.FixedAxis
 
binUpperEdge(int) - Method in class cern.hep.aida.ref.VariableAxis
 
binUpperEdge(int) - Method in class hep.aida.ref.histogram.FixedAxis
Get the upper edge of a bin.
binUpperEdge(int) - Method in class hep.aida.ref.histogram.VariableAxis
 
binUpperEdge(int) - Method in interface hep.aida.tdouble.DoubleIAxis
Upper edge of the specified bin.
binUpperEdge(int) - Method in class hep.aida.tdouble.ref.DoubleFixedAxis
 
binUpperEdge(int) - Method in class hep.aida.tdouble.ref.DoubleVariableAxis
 
binUpperEdge(int) - Method in interface hep.aida.tfloat.FloatIAxis
Upper edge of the specified bin.
binUpperEdge(int) - Method in class hep.aida.tfloat.ref.FloatFixedAxis
 
binUpperEdge(int) - Method in class hep.aida.tfloat.ref.FloatVariableAxis
 
binUpperEdge(int) - Method in class jhplot.H1D
Get bin upper edge.
binUpperEdge(int) - Method in class jhplot.HProf1D
Get bin upper edge.
binUpperEdges() - Method in class jhplot.H1D
Get all upper edges in form of array
binUpperEdges() - Method in class jhplot.HProf1D
Get all upper edges in form of array
binWidth(int) - Method in class cern.hep.aida.ref.FixedAxis
 
binWidth(int) - Method in class cern.hep.aida.ref.VariableAxis
 
binWidth(int) - Method in class hep.aida.ref.histogram.FixedAxis
Get the bin width.
binWidth(int) - Method in class hep.aida.ref.histogram.VariableAxis
 
binWidth(int) - Method in interface hep.aida.tdouble.DoubleIAxis
Width of the bin specified.
binWidth(int) - Method in class hep.aida.tdouble.ref.DoubleFixedAxis
 
binWidth(int) - Method in class hep.aida.tdouble.ref.DoubleVariableAxis
 
binWidth(int) - Method in interface hep.aida.tfloat.FloatIAxis
Width of the bin specified.
binWidth(int) - Method in class hep.aida.tfloat.ref.FloatFixedAxis
 
binWidth(int) - Method in class hep.aida.tfloat.ref.FloatVariableAxis
 
bisection(double, double, MathFunction, double) - Static method in class umontreal.iro.lecuyer.util.RootFinder
Computes a root x of the function in f using the bisection method.
BisectionRootFinder - Class in jhplot.math.num.root
The bisection method (1) for finding roots of functions.
BisectionRootFinder(Function) - Constructor for class jhplot.math.num.root.BisectionRootFinder
Create a root finder for the given function.
BisectionRootFinder(Function, int, double) - Constructor for class jhplot.math.num.root.BisectionRootFinder
Create a root finder for the given function.
BisectionSolver - Class in org.apache.commons.math.analysis.solvers
Implements the bisection algorithm for finding zeros of univariate real functions.
BisectionSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.solvers.BisectionSolver
Deprecated. as of 2.0 the function to solve is passed as an argument to the BisectionSolver.solve(UnivariateRealFunction, double, double) or UnivariateRealSolver.solve(UnivariateRealFunction, double, double, double) method.
BisectionSolver() - Constructor for class org.apache.commons.math.analysis.solvers.BisectionSolver
Construct a solver.
BiStudentDist - Class in umontreal.iro.lecuyer.probdistmulti
Extends the class ContinuousDistribution2Dim for the standard bivariate Student's t distribution.
BiStudentDist(int, double) - Constructor for class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
Constructs a BiStudentDist object with correlation ρ = rho and ν = nu degrees of freedom.
bitArray(int) - Method in class flanagan.math.PsRandom
 
bitMaskWithBitsSetFromTo(int, int) - Static method in class cern.colt.bitvector.QuickBitVector
Returns a bit mask with bits in the specified range set to 1, all the rest set to 0.
bitMaskWithBitsSetFromTo(int, int) - Static method in class cern.colt.matrix.tbit.QuickBitVector
Returns a bit mask with bits in the specified range set to 1, all the rest set to 0.
BitMatrix - Class in cern.colt.bitvector
Fixed sized (non resizable) n*m bit matrix.
BitMatrix(int, int) - Constructor for class cern.colt.bitvector.BitMatrix
Constructs a bit matrix with a given number of columns and rows.
BitMatrix - Class in cern.colt.matrix.tbit
Fixed sized (non resizable) n*m bit matrix.
BitMatrix(int, int) - Constructor for class cern.colt.matrix.tbit.BitMatrix
Constructs a bit matrix with a given number of columns and rows.
BitMatrix - Class in umontreal.iro.lecuyer.util
This class implements matrices of bits of arbitrary dimensions.
BitMatrix(int, int) - Constructor for class umontreal.iro.lecuyer.util.BitMatrix
Creates a new BitMatrix with r rows and c columns filled with 0's.
BitMatrix(BitVector[]) - Constructor for class umontreal.iro.lecuyer.util.BitMatrix
Creates a new BitMatrix using the data in rows.
BitMatrix(int[][], int, int) - Constructor for class umontreal.iro.lecuyer.util.BitMatrix
Creates a new BitMatrix with r rows and c columns using the data in data.
BitMatrix(BitMatrix) - Constructor for class umontreal.iro.lecuyer.util.BitMatrix
Copy constructor.
BitMatrix.IncompatibleDimensionException - Exception in umontreal.iro.lecuyer.util
Runtime exception raised when the dimensions of the BitMatrix are not appropriate for the operation.
bitsPerElement() - Method in class cern.colt.list.MinMaxNumberList
Returns the number of bits necessary to store a single element.
bitsPerElement(long, long) - Static method in class cern.colt.list.MinMaxNumberList
Returns the number of bits necessary to store values in the range [minimum,maximum].
bitsPerElement() - Method in class cern.colt.list.tlong.MinMaxNumberList
Returns the number of bits necessary to store a single element.
bitsPerElement(long, long) - Static method in class cern.colt.list.tlong.MinMaxNumberList
Returns the number of bits necessary to store values in the range [minimum,maximum].
BitsStreamGenerator - Class in org.apache.commons.math.random
Base class for random number generators that generates bits streams.
BitsStreamGenerator() - Constructor for class org.apache.commons.math.random.BitsStreamGenerator
Creates a new random number generator.
BitVector - Class in cern.colt.bitvector
Fixed sized (non resizable) bitvector.
BitVector(long[], int) - Constructor for class cern.colt.bitvector.BitVector
You normally need not use this method.
BitVector(int) - Constructor for class cern.colt.bitvector.BitVector
Constructs a bit vector that holds size bits.
BitVector - Class in cern.colt.matrix.tbit
Fixed sized (non resizable) bitvector.
BitVector(long[], int) - Constructor for class cern.colt.matrix.tbit.BitVector
You normally need not use this method.
BitVector(int) - Constructor for class cern.colt.matrix.tbit.BitVector
Constructs a bit vector that holds size bits.
BitVector - Class in umontreal.iro.lecuyer.util
This class implements vectors of bits and the operations needed to use them.
BitVector(int) - Constructor for class umontreal.iro.lecuyer.util.BitVector
Creates a new BitVector of length length with all its bits set to 0.
BitVector(int[], int) - Constructor for class umontreal.iro.lecuyer.util.BitVector
Creates a new BitVector of length length using the data in vect.
BitVector(int[]) - Constructor for class umontreal.iro.lecuyer.util.BitVector
Creates a new BitVector using the data in vect.
BitVector(BitVector) - Constructor for class umontreal.iro.lecuyer.util.BitVector
Creates a copy of the BitVector that.
BivariateRealFunction - Interface in org.apache.commons.math.analysis
An interface representing a bivariate real function.
BivariateRealGridInterpolator - Interface in org.apache.commons.math.analysis.interpolation
Interface representing a bivariate real interpolating function where the sample points must be specified on a regular grid.
Blas - Interface in cern.colt.matrix.linalg
Subset of the BLAS (Basic Linear Algebra System); High quality "building block" routines for performing basic vector and matrix operations.
BLAS - Class in org.netlib.blas
BLAS provider which will attempt to access a native implementation and falling back to use F2J if none is available.
BLAS() - Constructor for class org.netlib.blas.BLAS
 
Blob(float, float) - Static method in class jhplot.jadraw.Diagram
Get a blob object
blocEnd() - Method in class flanagan.math.TimeAndDate
 
BLOCK_SIZE - Static variable in class org.apache.commons.math.linear.BlockFieldMatrix
Block size.
BLOCK_SIZE - Static variable in class org.apache.commons.math.linear.BlockRealMatrix
Block size.
BlockFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math.linear
Cache-friendly implementation of FieldMatrix using a flat arrays to store square blocks of the matrix.
BlockFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math.linear.BlockFieldMatrix
Create a new matrix with the supplied row and column dimensions.
BlockFieldMatrix(T[][]) - Constructor for class org.apache.commons.math.linear.BlockFieldMatrix
Create a new dense matrix copying entries from raw layout data.
BlockFieldMatrix(int, int, T[][], boolean) - Constructor for class org.apache.commons.math.linear.BlockFieldMatrix
Create a new dense matrix copying entries from block layout data.
BlockRealMatrix - Class in org.apache.commons.math.linear
Cache-friendly implementation of RealMatrix using a flat arrays to store square blocks of the matrix.
BlockRealMatrix(int, int) - Constructor for class org.apache.commons.math.linear.BlockRealMatrix
Create a new matrix with the supplied row and column dimensions.
BlockRealMatrix(double[][]) - Constructor for class org.apache.commons.math.linear.BlockRealMatrix
Create a new dense matrix copying entries from raw layout data.
BlockRealMatrix(int, int, double[][], boolean) - Constructor for class org.apache.commons.math.linear.BlockRealMatrix
Create a new dense matrix copying entries from block layout data.
blocStart() - Method in class flanagan.math.TimeAndDate
 
blocTime() - Method in class flanagan.math.TimeAndDate
 
Bohr_radius - Static variable in class cern.clhep.PhysicalConstants
 
BooleanArrayList - Class in cern.colt.list
Resizable list holding boolean elements; implemented with arrays.
BooleanArrayList() - Constructor for class cern.colt.list.BooleanArrayList
Constructs an empty list.
BooleanArrayList(boolean[]) - Constructor for class cern.colt.list.BooleanArrayList
Constructs a list containing the specified elements.
BooleanArrayList(int) - Constructor for class cern.colt.list.BooleanArrayList
Constructs an empty list with the specified initial capacity.
BooleanArrayList - Class in cern.colt.list.tboolean
Resizable list holding boolean elements; implemented with arrays.
BooleanArrayList() - Constructor for class cern.colt.list.tboolean.BooleanArrayList
Constructs an empty list.
BooleanArrayList(boolean[]) - Constructor for class cern.colt.list.tboolean.BooleanArrayList
Constructs a list containing the specified elements.
BooleanArrayList(int) - Constructor for class cern.colt.list.tboolean.BooleanArrayList
Constructs an empty list with the specified initial capacity.
BooleanBuffer - Class in cern.colt.buffer.tboolean
Fixed sized (non resizable) streaming buffer connected to a target BooleanBufferConsumer to which data is automatically flushed upon buffer overflow.
BooleanBuffer(BooleanBufferConsumer, int) - Constructor for class cern.colt.buffer.tboolean.BooleanBuffer
Constructs and returns a new buffer with the given target.
BooleanBuffer2D - Class in cern.colt.buffer.tboolean
Fixed sized (non resizable) streaming buffer connected to a target BooleanBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
BooleanBuffer2D(BooleanBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.tboolean.BooleanBuffer2D
Constructs and returns a new buffer with the given target.
BooleanBuffer2DConsumer - Interface in cern.colt.buffer.tboolean
Target of a streaming BooleanBuffer2D into which data is flushed upon buffer overflow.
BooleanBuffer3D - Class in cern.colt.buffer.tboolean
Fixed sized (non resizable) streaming buffer connected to a target BooleanBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
BooleanBuffer3D(BooleanBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.tboolean.BooleanBuffer3D
Constructs and returns a new buffer with the given target.
BooleanBuffer3DConsumer - Interface in cern.colt.buffer.tboolean
Target of a streaming BooleanBuffer3D into which data is flushed upon buffer overflow.
BooleanBufferConsumer - Interface in cern.colt.buffer.tboolean
Target of a streaming BooleanBuffer into which data is flushed upon buffer overflow.
BooleanProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
BooleanProcedure - Interface in cern.colt.function.tboolean
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
boost(HEParticle) - Method in class hephysics.particle.HEParticle
Lorentz Boost
boost(LParticle) - Method in class hephysics.particle.LParticle
Lorentz Boost
boost(HepLorentzVector, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Boost fourVector with boostVector.
boost(HepLorentzVector, HepLorentzVector) - Method in class hephysics.vec.Hep3Vector
Boost fourVector into system of refFourVector.
boost(double, double, double) - Method in class hephysics.vec.HepLorentzVector
Lorentz Boost using 3-vector
boost(HepLorentzVector, Hep3Vector) - Method in class hephysics.vec.HepLorentzVector
Boost fourVector with boostVector.
boost(HepLorentzVector, HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Boost fourVector into system of refFourVector.
boost(HepLorentzVector, Hep3Vector) - Static method in class hephysics.vec.VecOp
Boost fourVector with boostVector.
boost(HepLorentzVector, HepLorentzVector) - Static method in class hephysics.vec.VecOp
Boost fourVector into system of refFourVector.
Box(float, float) - Static method in class jhplot.jadraw.Diagram
Get a box object
BoxChart - Class in umontreal.iro.lecuyer.charts
This class provides tools to create and manage box-and-whisker plots.
BoxChart() - Constructor for class umontreal.iro.lecuyer.charts.BoxChart
Initializes a new BoxChart instance with an empty data set.
BoxChart(String, String, String, double[], int) - Constructor for class umontreal.iro.lecuyer.charts.BoxChart
Initializes a new BoxChart instance with data data.
BoxChart(String, String, String, double[]...) - Constructor for class umontreal.iro.lecuyer.charts.BoxChart
Initializes a new BoxChart instance with data data.
BoxCox - Class in flanagan.analysis
 
BoxCox(double[]) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(float[]) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(int[]) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(long[]) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(short[]) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(byte[]) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(BigDecimal[]) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(BigInteger[]) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(Stat) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(ArrayMaths) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(ArrayList<Object>) - Constructor for class flanagan.analysis.BoxCox
 
BoxCox(Vector<Object>) - Constructor for class flanagan.analysis.BoxCox
 
BoxSeriesCollection - Class in umontreal.iro.lecuyer.charts
This class stores data used in a CategoryChart.
BoxSeriesCollection() - Constructor for class umontreal.iro.lecuyer.charts.BoxSeriesCollection
Creates a new BoxSeriesCollection instance with an empty dataset.
BoxSeriesCollection(double[], int) - Constructor for class umontreal.iro.lecuyer.charts.BoxSeriesCollection
Creates a new BoxSeriesCollection instance with default parameters and input series data.
BoxSeriesCollection(double[]...) - Constructor for class umontreal.iro.lecuyer.charts.BoxSeriesCollection
Creates a new BoxSeriesCollection instance with default parameters and given data series.
BoxSeriesCollection(DefaultBoxAndWhiskerCategoryDataset) - Constructor for class umontreal.iro.lecuyer.charts.BoxSeriesCollection
Creates a new BoxSeriesCollection instance with default parameters and given data series.
Bracket - Class in jhplot.math.num.root
Simple root bracketing routine.
Bracket(Function) - Constructor for class jhplot.math.num.root.Bracket
Create a root bracketer for the given function.
Bracket(Function, int) - Constructor for class jhplot.math.num.root.Bracket
Create a root bracketer for the given function.
bracket(UnivariateRealFunction, double, double, double) - Static method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverUtils
This method attempts to find two values a and b satisfying lowerBound <= a < initial < b <= upperBound f(a) * f(b) < 0 If f is continuous on [a,b], this means that a and b bracket a root of f.
bracket(UnivariateRealFunction, double, double, double, int) - Static method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverUtils
This method attempts to find two values a and b satisfying lowerBound <= a < initial < b <= upperBound f(a) * f(b) <= 0 If f is continuous on [a,b], this means that a and b bracket a root of f.
BracketFinder - Class in org.apache.commons.math.optimization.univariate
Provide an interval that brackets a local optimum of a function.
BracketFinder() - Constructor for class org.apache.commons.math.optimization.univariate.BracketFinder
Constructor with default values 100, 50 (see the other constructor).
BracketFinder(double, int) - Constructor for class org.apache.commons.math.optimization.univariate.BracketFinder
Create a bracketing interval finder.
bracketOut(double, double, double) - Method in class jhplot.math.num.root.Bracket
Bracket a root for the target function by creating and continuously expanding an interval around the initial point until the interval is known to contain at least one root.
BRAY_CURTIS - Static variable in class cern.colt.matrix.doublealgo.Statistic
Bray-Curtis distance function; Sum( abs(x[i]-y[i]) ) / Sum( x[i]+y[i] ).
BRAY_CURTIS - Static variable in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Bray-Curtis distance function; Sum( abs(x[i]-y[i]) ) / Sum( x[i]+y[i] ).
BRAY_CURTIS - Static variable in class cern.colt.matrix.tfloat.algo.FloatStatistic
Bray-Curtis distance function; Sum( abs(x[i]-y[i]) ) / Sum( x[i]+y[i] ).
BreitWigner - Class in cern.jet.random
BreitWigner (aka Lorentz) distribution; See the math definition.
BreitWigner(double, double, double, RandomEngine) - Constructor for class cern.jet.random.BreitWigner
Constructs a BreitWigner distribution.
BreitWigner - Class in cern.jet.random.tdouble
BreitWigner (aka Lorentz) distribution; See the math definition.
BreitWigner(double, double, double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.BreitWigner
Constructs a BreitWigner distribution.
BreitWigner - Class in jhplot.fit
Build a Breit-Wigner distribution.
BreitWigner() - Constructor for class jhplot.fit.BreitWigner
 
BreitWigner(String) - Constructor for class jhplot.fit.BreitWigner
 
BreitWigner(String[], String[]) - Constructor for class jhplot.fit.BreitWigner
 
BreitWignerMeanSquare - Class in cern.jet.random
Mean-square BreitWigner distribution; See the math definition.
BreitWignerMeanSquare(double, double, double, RandomEngine) - Constructor for class cern.jet.random.BreitWignerMeanSquare
Constructs a mean-squared BreitWigner distribution.
BreitWignerMeanSquare - Class in cern.jet.random.tdouble
Mean-square BreitWigner distribution; See the math definition.
BreitWignerMeanSquare(double, double, double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.BreitWignerMeanSquare
Constructs a mean-squared BreitWigner distribution.
brentDekker(double, double, MathFunction, double) - Static method in class umontreal.iro.lecuyer.util.RootFinder
Computes a root x of the function in f using the Brent-Dekker method.
BrentOptimizer - Class in org.apache.commons.math.optimization.univariate
Implements Richard Brent's algorithm (from his book "Algorithms for Minimization without Derivatives", p.
BrentOptimizer() - Constructor for class org.apache.commons.math.optimization.univariate.BrentOptimizer
Construct a solver.
BrentRootFinder - Class in jhplot.math.num.root
Brent's method (1) for finding roots of functions.
BrentRootFinder(Function) - Constructor for class jhplot.math.num.root.BrentRootFinder
Create a root finder for the given function.
BrentRootFinder(Function, int, double) - Constructor for class jhplot.math.num.root.BrentRootFinder
Create a root finder for the given function.
BrentSolver - Class in org.apache.commons.math.analysis.solvers
Implements the Brent algorithm for finding zeros of real univariate functions.
BrentSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.solvers.BrentSolver
Deprecated. as of 2.0 the function to solve is passed as an argument to the BrentSolver.solve(UnivariateRealFunction, double, double) or UnivariateRealSolver.solve(UnivariateRealFunction, double, double, double) method.
BrentSolver() - Constructor for class org.apache.commons.math.analysis.solvers.BrentSolver
Deprecated. in 2.2 (to be removed in 3.0).
BrentSolver(double) - Constructor for class org.apache.commons.math.analysis.solvers.BrentSolver
Construct a solver with the given absolute accuracy.
BrentSolver(int, double) - Constructor for class org.apache.commons.math.analysis.solvers.BrentSolver
Contstruct a solver with the given maximum iterations and absolute accuracy.
BRoot - Class in jhplot
Show Java ROOT browser to view ROOT histograms.
BRoot() - Constructor for class jhplot.BRoot
Show an empty frame with the ROOT browser
BRoot(String) - Constructor for class jhplot.BRoot
Show a frame with ROOT browser and load a file
BrownianMotion - Class in umontreal.iro.lecuyer.stochprocess
This class represents a Brownian motion process {X(t) : t >= 0}, sampled at times 0 = t0 < t1 < ...
BrownianMotion(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Constructs a new BrownianMotion with parameters μ = mu, σ = sigma and initial value X(t0) = x0.
BrownianMotion(double, double, double, NormalGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Constructs a new BrownianMotion with parameters μ = mu, σ = sigma and initial value X(t0) = x0.
BrownianMotionBridge - Class in umontreal.iro.lecuyer.stochprocess
Represents a Brownian motion process {X(t) : t >= 0} sampled using the bridge sampling technique (see for example).
BrownianMotionBridge(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.BrownianMotionBridge
Constructs a new BrownianMotionBridge with parameters μ = mu, σ = sigma and initial value X(t0) = x0.
BrownianMotionBridge(double, double, double, NormalGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.BrownianMotionBridge
Constructs a new BrownianMotionBridge with parameters μ = mu, σ = sigma and initial value X(t0) = x0.
BrownianMotionPCA - Class in umontreal.iro.lecuyer.stochprocess
A Brownian motion process {X(t) : t >= 0} sampled using the principal component decomposition (PCA).
BrownianMotionPCA(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCA
Constructs a new BrownianMotionBridge with parameters μ = mu, σ = sigma and initial value X(t0) = x0.
BrownianMotionPCA(double, double, double, NormalGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCA
Constructs a new BrownianMotionBridge with parameters μ = mu, σ = sigma and initial value X(t0) = x0.
BrownianMotionPCAEqualSteps - Class in umontreal.iro.lecuyer.stochprocess
Same as BrownianMotionPCA, but uses a trick to speed up the calculation when the time steps are equidistant.
BrownianMotionPCAEqualSteps(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCAEqualSteps
Constructs a new BrownianMotionPCAEqualSteps.
BrownianMotionPCAEqualSteps(double, double, double, NormalGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCAEqualSteps
Constructs a new BrownianMotionPCAEqualSteps.
Bsom - Class in jhplot.bsom
Bsom is an application of Bayesian Self-Organizing Maps.
Bsom() - Constructor for class jhplot.bsom.Bsom
 
bsom - Variable in class jhplot.HBsom
 
BsomDemo - Class in jhplot.bsom
BsomDemo is an applet for the demonstration of Bayesian Self-Organizing Maps.
BsomDemo() - Constructor for class jhplot.bsom.BsomDemo
 
BSpline - Class in umontreal.iro.lecuyer.functionfit
Represents a B-spline with control points at (Xi, Yi).
BSpline(double[], double[], int) - Constructor for class umontreal.iro.lecuyer.functionfit.BSpline
Constructs a new uniform B-spline of degree degree with control points at (x[i], y[i]).
BSpline(double[], double[], double[]) - Constructor for class umontreal.iro.lecuyer.functionfit.BSpline
Constructs a new uniform B-spline with control points at (x[i], y[i]), and knot vector given by the array knots.
Buffer - Class in cern.jet.stat
A buffer holding elements; internally used for computing approximate quantiles.
Buffer(int) - Constructor for class cern.jet.stat.Buffer
This method was created in VisualAge.
buffer - Variable in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
 
buffered(int) - Method in class cern.hep.aida.bin.AbstractBin1D
Constructs and returns a streaming buffer connected to the receiver.
buffered(int) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Constructs and returns a streaming buffer connected to the receiver.
buffered(int) - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Constructs and returns a streaming buffer connected to the receiver.
BufferSet - Class in cern.jet.stat
An abstract set of buffers; internally used for computing approximate quantiles.
BufferSet() - Constructor for class cern.jet.stat.BufferSet
 
buildMessage(Locale, Localizable, Object...) - Static method in class org.apache.commons.math.exception.util.MessageFactory
Builds a message string by from a pattern and its arguments.
buildMessage(Locale, Localizable, Localizable, Object...) - Static method in class org.apache.commons.math.exception.util.MessageFactory
Builds a message string by from two patterns (specific and general) and an argument list.
buildPads(int, int) - Method in class jhplot.HPlotJa
Build axes frames and show them.
buildXY(double, double, double[]) - Static method in class jhplot.math.DoubleArray
Generate a two column matrix.
buildXY(double[], double[]) - Static method in class jhplot.math.DoubleArray
Join two arrays into a matrix.
BunchingParameters - Class in jhplot.stat
**************************************************************************** Calculations of bunching parameters characterizing local multiplicity fluctuations inside a phase space.
BunchingParameters(int, int, int, double, double) - Constructor for class jhplot.stat.BunchingParameters
Initialize Bunching parameter.
burnsNight() - Method in class flanagan.math.TimeAndDate
 
burnsNight(int) - Method in class flanagan.math.TimeAndDate
 
ByteArrayList - Class in cern.colt.list
Resizable list holding byte elements; implemented with arrays.
ByteArrayList() - Constructor for class cern.colt.list.ByteArrayList
Constructs an empty list.
ByteArrayList(byte[]) - Constructor for class cern.colt.list.ByteArrayList
Constructs a list containing the specified elements.
ByteArrayList(int) - Constructor for class cern.colt.list.ByteArrayList
Constructs an empty list with the specified initial capacity.
ByteArrayList - Class in cern.colt.list.tbyte
Resizable list holding byte elements; implemented with arrays.
ByteArrayList() - Constructor for class cern.colt.list.tbyte.ByteArrayList
Constructs an empty list.
ByteArrayList(byte[]) - Constructor for class cern.colt.list.tbyte.ByteArrayList
Constructs a list containing the specified elements.
ByteArrayList(int) - Constructor for class cern.colt.list.tbyte.ByteArrayList
Constructs an empty list with the specified initial capacity.
ByteBuffer - Class in cern.colt.buffer.tbyte
Fixed sized (non resizable) streaming buffer connected to a target ByteBufferConsumer to which data is automatically flushed upon buffer overflow.
ByteBuffer(ByteBufferConsumer, int) - Constructor for class cern.colt.buffer.tbyte.ByteBuffer
Constructs and returns a new buffer with the given target.
ByteBuffer2D - Class in cern.colt.buffer.tbyte
Fixed sized (non resizable) streaming buffer connected to a target ByteBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
ByteBuffer2D(ByteBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.tbyte.ByteBuffer2D
Constructs and returns a new buffer with the given target.
ByteBuffer2DConsumer - Interface in cern.colt.buffer.tbyte
Target of a streaming ByteBuffer2D into which data is flushed upon buffer overflow.
ByteBuffer3D - Class in cern.colt.buffer.tbyte
Fixed sized (non resizable) streaming buffer connected to a target ByteBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
ByteBuffer3D(ByteBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.tbyte.ByteBuffer3D
Constructs and returns a new buffer with the given target.
ByteBuffer3DConsumer - Interface in cern.colt.buffer.tbyte
Target of a streaming ByteBuffer3D into which data is flushed upon buffer overflow.
ByteBufferConsumer - Interface in cern.colt.buffer.tbyte
Target of a streaming ByteBuffer into which data is flushed upon buffer overflow.
ByteComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
ByteComparator - Interface in cern.colt.function.tbyte
A comparison function which imposes a total ordering on some collection of elements.
ByteFunction - Interface in cern.colt.function.tbyte
Interface that represents a function object: a function that takes a single argument and returns a single value.
ByteProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
ByteProcedure - Interface in cern.colt.function.tbyte
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
byteTOdouble(byte[]) - Static method in class flanagan.math.Fmath
 
byteTOfloat(byte[]) - Static method in class flanagan.math.Fmath
 
byteTOint(byte[]) - Static method in class flanagan.math.Fmath
 
byteTOlong(byte[]) - Static method in class flanagan.math.Fmath
 
byteTOshort(byte[]) - Static method in class flanagan.math.Fmath
 

C

c_light - Static variable in class cern.clhep.PhysicalConstants
 
C_LIGHT - Static variable in class flanagan.math.Fmath
 
c_squared - Static variable in class cern.clhep.PhysicalConstants
 
CachedPointSet - Class in umontreal.iro.lecuyer.hups
This container class caches a point set by precomputing and storing its points locally in an array.
CachedPointSet(PointSet, int, int) - Constructor for class umontreal.iro.lecuyer.hups.CachedPointSet
Creates a new PointSet object that contains an array storing the first dim coordinates of the first n points of P.
CachedPointSet(PointSet) - Constructor for class umontreal.iro.lecuyer.hups.CachedPointSet
Creates a new PointSet object that contains an array storing the points of P.
calcBMIimperial(double, double) - Static method in class flanagan.math.Conv
 
calcBMIimperial(double, double) - Static method in class flanagan.math.Fmath
 
calcBMImetric(double, double) - Static method in class flanagan.math.Conv
 
calcBMImetric(double, double) - Static method in class flanagan.math.Fmath
 
calcDataLength(boolean, int, int) - Static method in class flanagan.math.FourierTransform
 
calcDeriv() - Method in class flanagan.interpolation.CubicSpline
 
calcDeriv() - Method in class flanagan.interpolation.CubicSplineFast
 
calcDeriv() - Method in class flanagan.interpolation.CubicSplineShort
 
calcDistance(double[], double[]) - Static method in class jminhep.cluster.Get
This method calculates the Euclidean distance between two N-ncolsional vectors.
calcMass() - Method in class hephysics.particle.LParticle
Get calculated mass as sqrt(e*e-px**2-py**2-pz**2)
calcMatStirling(int, int) - Static method in class umontreal.iro.lecuyer.util.Num
Computes and returns the Stirling numbers of the second kind
calcSquaredDistance(double[], double[]) - Static method in class jminhep.cluster.Get
This method calculates the squared distance between two N-dimesional vectors.
calculateAdjustedRSquared() - Method in class org.apache.commons.math.stat.regression.OLSMultipleLinearRegression
Returns the adjusted R-squared statistic, defined by the formula
calculateCumulativeValues(double[], double[], double[], ErrorProp[], int, double, double, String) - Method in class flanagan.analysis.Regression
 
calculateHat() - Method in class org.apache.commons.math.stat.regression.OLSMultipleLinearRegression
Compute the "hat" matrix.
calculateNormalizationAmplitude() - Method in class hep.aida.ref.function.BaseModelFunction
 
calculateResidualSumOfSquares() - Method in class org.apache.commons.math.stat.regression.OLSMultipleLinearRegression
Returns the sum of squared residuals.
calculateRSquared() - Method in class org.apache.commons.math.stat.regression.OLSMultipleLinearRegression
Returns the R-Squared statistic, defined by the formula
calculateTotalSumOfSquares() - Method in class org.apache.commons.math.stat.regression.OLSMultipleLinearRegression
Returns the sum of squared deviations of Y from its mean.
calcWeightFromBMIimperial(double, double) - Static method in class flanagan.math.Conv
 
calcWeightFromBMIimperial(double, double) - Static method in class flanagan.math.Fmath
 
calcWeightFromBMImetric(double, double) - Static method in class flanagan.math.Conv
 
calcWeightFromBMImetric(double, double) - Static method in class flanagan.math.Fmath
 
calorieToJoule(double) - Static method in class flanagan.math.Conv
 
calorieToJoule(double) - Static method in class flanagan.math.Fmath
 
CANBERRA - Static variable in class cern.colt.matrix.doublealgo.Statistic
Canberra distance function; Sum( abs(x[i]-y[i]) / abs(x[i]+y[i]) ).
CANBERRA - Static variable in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Canberra distance function; Sum( abs(x[i]-y[i]) / abs(x[i]+y[i]) ).
CANBERRA - Static variable in class cern.colt.matrix.tfloat.algo.FloatStatistic
Canberra distance function; Sum( abs(x[i]-y[i]) / abs(x[i]+y[i]) ).
cancel() - Method in class umontreal.iro.lecuyer.simevents.Event
Cancels this event before it occurs.
cancel(String) - Method in class umontreal.iro.lecuyer.simevents.Event
Finds the first occurence of an event of class ``type'' in the event list, and cancels it.
cancel() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Cancels the activating event that was supposed to resume this process, and places the process in the SUSPENDED state.
candela - Static variable in class cern.clhep.Units
 
candlemas() - Method in class flanagan.math.TimeAndDate
 
candlemas(int) - Method in class flanagan.math.TimeAndDate
 
Canvas3d - Class in jhplot.v3d
 
Canvas3d(Model3d) - Constructor for class jhplot.v3d.Canvas3d
 
captureHeader(CSVReader) - Method in class jhplot.io.csv.bean.ColumnPositionMappingStrategy
 
captureHeader(CSVReader) - Method in class jhplot.io.csv.bean.HeaderColumnNameMappingStrategy
 
captureHeader(CSVReader) - Method in interface jhplot.io.csv.bean.MappingStrategy
Implemention of this method can grab the header line before parsing begins to use to map columns to bean properties.
CardanEulerSingularityException - Exception in org.apache.commons.math.geometry
This class represents exceptions thrown while extractiong Cardan or Euler angles from a rotation.
CardanEulerSingularityException(boolean) - Constructor for exception org.apache.commons.math.geometry.CardanEulerSingularityException
Simple constructor.
cardinality() - Method in class cern.colt.bitvector.BitMatrix
Returns the number of bits currently in the true state.
cardinality() - Method in class cern.colt.bitvector.BitVector
Returns the number of bits currently in the true state.
cardinality() - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.DoubleMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.DoubleMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.ObjectMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.ObjectMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.ObjectMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tbit.BitMatrix
Returns the number of bits currently in the true state.
cardinality() - Method in class cern.colt.matrix.tbit.BitVector
Returns the number of bits currently in the true state.
cardinality() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
cardinality() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
cardinality() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
cardinality() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
cardinality() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
cardinality() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tint.IntMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tint.IntMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
cardinality() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
cardinality() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Returns the number of cells having non-zero values.
cardinality() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
cardinality() - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Returns the number of cells having non-zero values; ignores tolerance.
cardinality() - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Returns the number of cells having non-zero values; ignores tolerance.
cashKarp(DerivFunction) - Method in class flanagan.integration.RungeKutta
 
cashKarp(DerivFunction, double, double, double, double, double, double, int) - Static method in class flanagan.integration.RungeKutta
 
cashKarp(DerivFunction, double, double, double, double, double, double) - Static method in class flanagan.integration.RungeKutta
 
cashKarp(DerivnFunction) - Method in class flanagan.integration.RungeKutta
 
cashKarp(DerivnFunction, double, double[], double, double, double, double, int) - Static method in class flanagan.integration.RungeKutta
 
cashKarp(DerivnFunction, double, double[], double, double, double, double) - Static method in class flanagan.integration.RungeKutta
 
catalog() - Method in class hep.aida.ref.function.FunctionFactory
get access to the function catalog
CategoryChart - Class in umontreal.iro.lecuyer.charts
This class provides tools to create charts from data in a simple way.
CategoryChart() - Constructor for class umontreal.iro.lecuyer.charts.CategoryChart
 
Cauchy - Class in jhplot.math.num.pdf
The Cauchy distribution (1).
Cauchy() - Constructor for class jhplot.math.num.pdf.Cauchy
Default constructor.
Cauchy(double, double) - Constructor for class jhplot.math.num.pdf.Cauchy
Create a distribution with the given location and scale parameters.
cauchy(double, double) - Static method in class jhplot.math.Random
Generate a random number from a Cauchy random variable (Mean = Inf, and Variance = Inf).
CauchyDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Cauchy distribution with location parameter α and scale parameter β > 0.
CauchyDist() - Constructor for class umontreal.iro.lecuyer.probdist.CauchyDist
Constructs a CauchyDist object with parameters α = 0 and β = 1.
CauchyDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.CauchyDist
Constructs a CauchyDist object with parameters α = alpha and β = beta.
CauchyDistribution - Interface in org.apache.commons.math.distribution
Cauchy Distribution.
CauchyDistributionImpl - Class in org.apache.commons.math.distribution
Default implementation of CauchyDistribution.
CauchyDistributionImpl() - Constructor for class org.apache.commons.math.distribution.CauchyDistributionImpl
Creates cauchy distribution with the medain equal to zero and scale equal to one.
CauchyDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.CauchyDistributionImpl
Create a cauchy distribution using the given median and scale.
CauchyDistributionImpl(double, double, double) - Constructor for class org.apache.commons.math.distribution.CauchyDistributionImpl
Create a cauchy distribution using the given median and scale.
CauchyGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the Cauchy distribution.
CauchyGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.CauchyGen
Creates a Cauchy random variate generator with parameters α = alpha and β = beta, using stream s.
CauchyGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.CauchyGen
Creates a Cauchy random variate generator with parameters α = 0 and β = 1, using stream s.
CauchyGen(RandomStream, CauchyDist) - Constructor for class umontreal.iro.lecuyer.randvar.CauchyGen
Create a new generator for the distribution dist, using stream s.
CauchyRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Cauchy distribution.
CauchyRandomVariable() - Constructor for class jhplot.math.num.random.CauchyRandomVariable
Default constructor.
CauchyRandomVariable(double, double) - Constructor for class jhplot.math.num.random.CauchyRandomVariable
Create a random variable with the given location and scale parameters.
CauchyRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.CauchyRandomVariable
Create a random variable with the given parameters.
CBRT - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.cbrt method wrapped as a ComposableFunction.
cbrt(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the cubic root of a number.
cd(String) - Method in class hep.aida.ref.tree.Tree
Change to a given directory.
cd(int, int) - Method in class jhplot.GHFrame
Navigate to a selected plot.
cd(int, int) - Method in class jhplot.HPlotJa
Navigate to a selected plot.
cd(String) - Method in class jhplot.io.FileAida
Navigate to a directory inside the file
cd(String) - Method in class jhplot.io.FileRoot
Navigate to a directory inside the ROOT file.
cdf(double) - Method in class cern.jet.random.Beta
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.Binomial
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.ChiSquare
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.Empirical
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.EmpiricalWalker
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.Exponential
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.Gamma
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.NegativeBinomial
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.Normal
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.Poisson
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.StudentT
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.tdouble.Beta
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.tdouble.Binomial
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.tdouble.ChiSquare
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.tdouble.DoubleUniform
Returns the cumulative distribution function (assuming a continous uniform distribution).
cdf(int) - Method in class cern.jet.random.tdouble.Empirical
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.tdouble.EmpiricalWalker
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.tdouble.Exponential
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.tdouble.Gamma
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.tdouble.NegativeBinomial
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.tdouble.Normal
Returns the cumulative distribution function.
cdf(int) - Method in class cern.jet.random.tdouble.Poisson
Returns the cumulative distribution function.
cdf(double) - Method in class cern.jet.random.tdouble.StudentT
Returns the cumulative distribution function.
cdf(float) - Method in class cern.jet.random.tfloat.FloatUniform
Returns the cumulative distribution function (assuming a continous uniform distribution).
cdf(double) - Method in class cern.jet.random.Uniform
Returns the cumulative distribution function (assuming a continous uniform distribution).
cdf(int, double) - Static method in class jhplot.math.KolmogorovSmirnovDist
Computes the cumulative probability P[D_n <= x] of the Kolmogorov-Smirnov distribution with sample size n at x.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
Computes the Anderson-Darling distribution function Fn(x), with parameter n, using Marsaglia's and al.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDistQuick
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDistQuick
Computes the distribution function Fn(x) with parameter n.
cdf(int) - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
 
cdf(double, int) - Static method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Returns the Bernoulli distribution function F(x) with parameter p (see eq.).
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.BetaDist
 
cdf(double, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Same as cdf (alpha, beta, 0, 1, d, x).
cdf(double, double, double, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Computes an approximation of the distribution function, with roughly d decimal digits of precision.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
 
cdf(double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Same as cdf (alpha, alpha, d, x).
cdf(int) - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
 
cdf(int, double, int) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Computes F(x), the distribution function of a binomial random variable with parameters n and p, evaluated at x.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.CauchyDist
Computes the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.ChiDist
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiDist
Computes the distribution function by using the gamma distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
 
cdf(int, int, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Computes the chi-square distribution function with n degrees of freedom, evaluated at x.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Computes the noncentral chi-square distribution function with ν = nu degrees of freedom and parameter λ = lambda.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Computes the Cramér-von Mises distribution function with parameter n.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
 
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
Returns the distribution function F evaluated at x (see).
cdf(int) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
Returns the distribution function F evaluated at x (see).
cdf(double) - Method in interface umontreal.iro.lecuyer.probdist.Distribution
Returns the distribution function F(x).
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
 
cdf(int, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.ErlangDist
Computes the distribution function using the gamma distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
 
cdf(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Computes the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated.  
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. THIS CLASS HAS BEEN REPLACED BY GumbelDist.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
 
cdf(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Computes the fatigue life distribution function with parameters μ, β and γ.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
 
cdf(int, int, int, double) - Static method in class umontreal.iro.lecuyer.probdist.FisherFDist
Computes the distribution function of the Fisher F distribution with parameters n and m, evaluated at x, with roughly d decimal digits of precision.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Computes the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
 
cdf(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FrechetDist
Computes and returns the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.GammaDist
 
cdf(double, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Returns an approximation of the gamma distribution function with parameters α = alpha and λ = lambda.
cdf(double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Equivalent to cdf (alpha, 1.0, d, x).
cdf(int) - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
 
cdf(double, int) - Static method in class umontreal.iro.lecuyer.probdist.GeometricDist
Computes the distribution function F(x).
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Computes and returns the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Computes the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Computes the distribution function of the hyperbolic secant distribution with parameters μ and σ.
cdf(int) - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
 
cdf(int, int, int, int) - Static method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Computes the distribution function F(x).
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.InverseDistFromDensity
Computes the distribution function at x.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Computes the cumulative probability function of the inverse gamma distribution with shape parameter α and scale parameter β.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Computes the distribution function of the inverse gaussian distribution with parameters μ and λ, evaluated at x.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
 
cdf(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Computes the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
 
cdf(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Computes the distribution function F(x).
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
Computes the distribution function F(x) with parameter n using Durbin's matrix formula.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDistQuick
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDistQuick
Computes the distribution function u = P[Dn <= x] with parameter n, using the program described in.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
Computes the Kolmogorov-Smirnov+ distribution function Fn(x) with parameter n.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Computes the Laplace distribution function.
cdf(int) - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
 
cdf(double, int) - Static method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Computes the distribution function F(x).
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LogisticDist
Computes the distribution function F(x).
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Computes the distribution function of the log-logistic distribution with parameters α and β.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LognormalDist
Computes the lognormal distribution function, using cdf01.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
 
cdf(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Computes the distribution function.
cdf(int) - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
 
cdf(double, double, int) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Computes the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.NormalDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Computes the normal distribution function with mean μ and variance σ2.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.NormalDistQuick
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDistQuick
Returns an approximation of Φ(x), where Φ is the standard normal distribution function, with mean 0 and variance 1.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
 
cdf(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
NOT IMPLEMENTED.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ParetoDist
Computes the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Computes the density function of a Pearson V distribution with shape parameter α and scale parameter β.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
 
cdf(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Computes the distribution function of a Pearson VI distribution with shape parameters α1 and α2, and scale parameter β.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
 
cdf(int) - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
 
cdf(double, int) - Static method in class umontreal.iro.lecuyer.probdist.PoissonDist
Computes and returns the value of the Poisson distribution function F(x) for λ = lambda.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.PowerDist
 
cdf(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.PowerDist
Computes the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Computes the distribution function.
cdf(double, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Same as cdf (0, beta, x).
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.StudentDist
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.StudentDist
Computes the Student t-distribution function u = F(x) with n degrees of freedom.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.StudentDistQuick
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.StudentDistQuick
Returns an approximation of the Student t-distribution function with n degrees of freedom.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
 
cdf(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.TriangularDist
Computes the distribution function.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
 
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.UniformDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.UniformDist
Computes the uniform distribution function as in.
cdf(int) - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
 
cdf(int, int, int) - Static method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Computes the discrete uniform distribution function defined in.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.WatsonGDist
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.WatsonGDist
Computes the Watson G distribution function Fn(x), with parameter n.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
 
cdf(int, double) - Static method in class umontreal.iro.lecuyer.probdist.WatsonUDist
Computes the Watson U distribution function, i.e.
cdf(double) - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
 
cdf(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Computes the distribution function.
cdf(double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Same as cdf (alpha, 1, 0, x).
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Computes the standard binormal distribution using the fast Drezner-Wesolowsky method described in.
cdf(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
 
cdf(double, double, double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Computes the binormal distribution function with parameters μ1 = mu1, μ2 = mu2, σ1 = sigma1, σ2 = sigma2 and ρ = rho.
cdf(double, double, double, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
Computes the standard binormal distribution with the method described in, where ndig is the number of decimal digits of accuracy provided (ndig  <= 15).
cdf(double, double, double, double, double, double, double, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
Computes the binormal distribution function with parameters μ1 = mu1, μ2 = mu2, σ1 = sigma1, σ2 = sigma2, correlation ρ = rho and ndig decimal digits of accuracy.
cdf(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
 
cdf(double, double, double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDonnellyDist
 
cdf(double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalGenzDist
Computes the standard binormal distribution with the method described in.
cdf(double, double, double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalGenzDist
 
cdf(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalGenzDist
 
cdf(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
 
cdf(int, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
Computes the standard bivariate Student's t distribution using the method described in.
cdf(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistribution2Dim
.
cdf(double, double, double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistribution2Dim
.
cdf(int[]) - Method in class umontreal.iro.lecuyer.probdistmulti.DiscreteDistributionIntMulti
Computes the cumulative probability function F of the distribution evaluated at x, assuming the lowest values start at 0, i.e.
cdf(int[]) - Method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
 
cdf(int, double[], int[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Computes the function F of the multinomial distribution with parameters n and (p1,...,pd) evaluated at x.
cdf(double, double[], int[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Computes the cumulative probability function F of the negative multinomial distribution with parameters γ and (p1,...,pk), evaluated at x.
cdf01(double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Same as cdf (0, 1, x).
cdf01(double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDistQuick
Same as cdf (0.0, 1.0, x).
cdf2(int, int, double) - Static method in class umontreal.iro.lecuyer.probdist.StudentDist
Deprecated. 
ceil(double) - Static method in class cern.jet.math.Arithmetic
Returns the smallest long >= value.
ceil - Static variable in class cern.jet.math.Functions
Function that returns Math.ceil(a).
ceil(double) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Returns the smallest long >= value.
ceil - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.ceil(a).
ceil(float) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Returns the smallest long >= value.
ceil - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.ceil(a).
ceil() - Method in class flanagan.analysis.Stat
 
ceil() - Method in class flanagan.math.ArrayMaths
 
CEIL - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.ceil method wrapped as a ComposableFunction.
ceil() - Method in class org.apache.commons.math.dfp.Dfp
Round to an integer using the round ceil mode.
ceil(double) - Static method in class org.apache.commons.math.util.FastMath
Get the smallest whole number larger than x.
celsiusToFahren(double) - Static method in class flanagan.math.Conv
 
celsiusToFahren(double) - Static method in class flanagan.math.Fmath
 
celsiusToKelvin(double) - Static method in class flanagan.math.Conv
 
celsiusToKelvin(double) - Static method in class flanagan.math.Fmath
 
CENTER - Static variable in class cern.colt.matrix.AbstractFormatter
The alignment string aligning the cells of a column to its center.
CENTER - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The alignment string aligning the cells of a column to its center.
center() - Method in class cern.hep.aida.bin.AbstractBin
Returns center(0).
center(int) - Method in class cern.hep.aida.bin.AbstractBin
Returns a custom definable "center" measure; override this method if necessary.
center() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns center(0).
center(int) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns a custom definable "center" measure; override this method if necessary.
center() - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns center(0).
center(int) - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns a custom definable "center" measure; override this method if necessary.
center_reduce(double[][]) - Method in class jhplot.stat.PCA
 
centerOfMass(List<Hep3Vector>) - Method in class hephysics.vec.Hep3Vector
Return a center of mass of a list of vectors
centerOfMass(List<HepLorentzVector>) - Method in class hephysics.vec.HepLorentzVector
Return a center mass vector
centimeter - Static variable in class cern.clhep.Units
 
centimeter2 - Static variable in class cern.clhep.Units
 
centimeter3 - Static variable in class cern.clhep.Units
 
centreWithin(Rectangle, Dimension) - Static method in class jhplot.v3d.Util
Calculates the X and Y coordinates that a child component should have to be centered within its parent.
centreWithin(Component, Component) - Static method in class jhplot.v3d.Util
Centres the child component within its parent.
centroidOf(Collection<T>) - Method in interface org.apache.commons.math.stat.clustering.Clusterable
Returns the centroid of the given Collection of points.
centroidOf(Collection<EuclideanIntegerPoint>) - Method in class org.apache.commons.math.stat.clustering.EuclideanIntegerPoint
Returns the centroid of the given Collection of points.
cern.clhep - package cern.clhep
A Java port of CLHEP 1.4.0 (C++) - A Class Library for High Energy Physics.
cern.colt - package cern.colt
Core base classes; Operations on primitive arrays such as sorting, partitioning and permuting.
cern.colt.bitvector - package cern.colt.bitvector
Bit vectors and bit matrices.
cern.colt.buffer - package cern.colt.buffer
Fixed sized (non resizable) streaming buffers connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.buffer.tboolean - package cern.colt.buffer.tboolean
Fixed sized (non resizable) streaming buffers holding boolean elements connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.buffer.tbyte - package cern.colt.buffer.tbyte
Fixed sized (non resizable) streaming buffers holding byte elements connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.buffer.tchar - package cern.colt.buffer.tchar
Fixed sized (non resizable) streaming buffers holding char elements connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.buffer.tdouble - package cern.colt.buffer.tdouble
Fixed sized (non resizable) streaming buffers holding double elements connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.buffer.tfloat - package cern.colt.buffer.tfloat
Fixed sized (non resizable) streaming buffers holding float elements connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.buffer.tint - package cern.colt.buffer.tint
Fixed sized (non resizable) streaming buffers holding int elements connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.buffer.tlong - package cern.colt.buffer.tlong
Fixed sized (non resizable) streaming buffers holding long elements connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.buffer.tobject - package cern.colt.buffer.tobject
Fixed sized (non resizable) streaming buffers holding Object elements connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.buffer.tshort - package cern.colt.buffer.tshort
Fixed sized (non resizable) streaming buffers holding short elements connected to a target objects to which data is automatically flushed upon buffer overflow.
cern.colt.function - package cern.colt.function
Core interfaces for functions, comparisons and procedures on objects and primitive data types.
cern.colt.function.tboolean - package cern.colt.function.tboolean
Core interfaces for functions, comparisons and procedures on boolean data type.
cern.colt.function.tbyte - package cern.colt.function.tbyte
Core interfaces for functions, comparisons and procedures on byte data type.
cern.colt.function.tchar - package cern.colt.function.tchar
Core interfaces for functions, comparisons and procedures on char data type.
cern.colt.function.tdcomplex - package cern.colt.function.tdcomplex
Core interfaces for functions, comparisons and procedures on dcomplex data type.
cern.colt.function.tdouble - package cern.colt.function.tdouble
Core interfaces for functions, comparisons and procedures on double data type.
cern.colt.function.tfcomplex - package cern.colt.function.tfcomplex
Core interfaces for functions, comparisons and procedures on fcomplex data type.
cern.colt.function.tfloat - package cern.colt.function.tfloat
Core interfaces for functions, comparisons and procedures on float data type.
cern.colt.function.tint - package cern.colt.function.tint
Core interfaces for functions, comparisons and procedures on int data type.
cern.colt.function.tlong - package cern.colt.function.tlong
Core interfaces for functions, comparisons and procedures on long data type.
cern.colt.function.tobject - package cern.colt.function.tobject
Core interfaces for functions, comparisons and procedures on Object data type.
cern.colt.function.tshort - package cern.colt.function.tshort
Core interfaces for functions, comparisons and procedures on short data type.
cern.colt.list - package cern.colt.list
Resizable lists holding objects or primitive data types such as int, double, etc.
cern.colt.list.adapter - package cern.colt.list.adapter
List adapters that make Colt lists compatible with the JDK 1.2 Collections Framework.
cern.colt.list.tboolean - package cern.colt.list.tboolean
Resizable list holding elements of boolean data type.
cern.colt.list.tbyte - package cern.colt.list.tbyte
Resizable list holding elements of byte data type.
cern.colt.list.tchar - package cern.colt.list.tchar
Resizable list holding elements of char data type.
cern.colt.list.tdouble - package cern.colt.list.tdouble
Resizable list holding elements of double data type.
cern.colt.list.tfloat - package cern.colt.list.tfloat
Resizable list holding elements of float data type.
cern.colt.list.tint - package cern.colt.list.tint
Resizable list holding elements of int data type.
cern.colt.list.tlong - package cern.colt.list.tlong
Resizable list holding elements of long data type.
cern.colt.list.tobject - package cern.colt.list.tobject
Resizable list holding elements of Object data type.
cern.colt.list.tshort - package cern.colt.list.tshort
Resizable list holding elements of short data type.
cern.colt.map - package cern.colt.map
Automatically growing and shrinking maps holding objects or primitive data types such as int, double, etc.
cern.colt.map.tdouble - package cern.colt.map.tdouble
Automatically growing and shrinking map holding elements of double data type.
cern.colt.map.tfloat - package cern.colt.map.tfloat
Automatically growing and shrinking map holding elements of float data type.
cern.colt.map.tint - package cern.colt.map.tint
Automatically growing and shrinking map holding elements of int data type.
cern.colt.map.tlong - package cern.colt.map.tlong
Automatically growing and shrinking map holding elements of long data type.
cern.colt.map.tobject - package cern.colt.map.tobject
Automatically growing and shrinking map holding elements of Object data type.
cern.colt.matrix - package cern.colt.matrix
 
cern.colt.matrix.bench - package cern.colt.matrix.bench
Matrix benchmarks.
cern.colt.matrix.doublealgo - package cern.colt.matrix.doublealgo
Double matrix algorithms such as print formatting, sorting, partitioning and statistics.
cern.colt.matrix.impl - package cern.colt.matrix.impl
Matrix implementations; You normally need not look at this package, because all concrete classes implement the abstract interfaces of cern.colt.matrix, without subsetting or supersetting.
cern.colt.matrix.io - package cern.colt.matrix.io
I/O operations with matrices and vectors.
cern.colt.matrix.linalg - package cern.colt.matrix.linalg
Linear Algebraic matrix computations operating on DoubleMatrix2D and DoubleMatrix1D.
cern.colt.matrix.objectalgo - package cern.colt.matrix.objectalgo
Object matrix algorithms such as print formatting, sorting, partitioning and statistics.
cern.colt.matrix.tbit - package cern.colt.matrix.tbit
Bit vectors and bit matrices.
cern.colt.matrix.tdcomplex - package cern.colt.matrix.tdcomplex
Matrix interfaces and factories holding elements of dcomplex data type.
cern.colt.matrix.tdcomplex.algo - package cern.colt.matrix.tdcomplex.algo
Algorithms operating on complex matrices.
cern.colt.matrix.tdcomplex.impl - package cern.colt.matrix.tdcomplex.impl
Efficient and flexible dense and sparse 1, 2 and 3-dimensional matrices holding elements of dcomplex data type.
cern.colt.matrix.tdouble - package cern.colt.matrix.tdouble
Matrix interfaces and factories holding elements of double data type.
cern.colt.matrix.tdouble.algo - package cern.colt.matrix.tdouble.algo
Linear Algebraic matrix computations operating on DoubleMatrix2D and DoubleMatrix1D.
cern.colt.matrix.tdouble.algo.decomposition - package cern.colt.matrix.tdouble.algo.decomposition
Martrix decompositions.
cern.colt.matrix.tdouble.algo.solver - package cern.colt.matrix.tdouble.algo.solver
Iterative solvers BiCG - BiConjugate gradients. BiCGstab - BiConjugate gradients stabilized. CG - Conjugate gradients. CGS - Conjugate gradients squared. Chebyshev - The Chebyshev iteration for symmetrical, positive definite matrices. GMRES - Generalized minimal residual using restart. IR - Iterative refinement (Richardson's method). QMR - Quasi-minimal residual. HyBR - Hybrid Bidiagonalization Regularization. MRNSD - Modified Residual Norm Steepest Descent. CGLS - Conjugate Gradient for Least Squares.
cern.colt.matrix.tdouble.algo.solver.preconditioner - package cern.colt.matrix.tdouble.algo.solver.preconditioner
Preconditioners for iterative solvers.
cern.colt.matrix.tdouble.impl - package cern.colt.matrix.tdouble.impl
Efficient and flexible dense and sparse 1, 2 and 3-dimensional matrices holding elements of double data type.
cern.colt.matrix.tfcomplex - package cern.colt.matrix.tfcomplex
Matrix interfaces and factories holding elements of fcomplex data type.
cern.colt.matrix.tfcomplex.algo - package cern.colt.matrix.tfcomplex.algo
Algorithms operating on complex matrices.
cern.colt.matrix.tfcomplex.impl - package cern.colt.matrix.tfcomplex.impl
Efficient and flexible dense and sparse 1, 2 and 3-dimensional matrices holding elements of fcomplex data type.
cern.colt.matrix.tfloat - package cern.colt.matrix.tfloat
Matrix interfaces and factories holding elements of float data type.
cern.colt.matrix.tfloat.algo - package cern.colt.matrix.tfloat.algo
Linear Algebraic matrix computations operating on FloatMatrix2D and FloatMatrix1D.
cern.colt.matrix.tfloat.algo.decomposition - package cern.colt.matrix.tfloat.algo.decomposition
Martrix decompositions.
cern.colt.matrix.tfloat.algo.solver - package cern.colt.matrix.tfloat.algo.solver
Iterative solvers BiCG - BiConjugate gradients. BiCGstab - BiConjugate gradients stabilized. CG - Conjugate gradients. CGS - Conjugate gradients squared. Chebyshev - The Chebyshev iteration for symmetrical, positive definite matrices. GMRES - Generalized minimal residual using restart. IR - Iterative refinement (Richardson's method). QMR - Quasi-minimal residual. HyBR - Hybrid Bidiagonalization Regularization. MRNSD - Modified Residual Norm Steepest Descent. CGLS - Conjugate Gradient for Least Squares.
cern.colt.matrix.tfloat.algo.solver.preconditioner - package cern.colt.matrix.tfloat.algo.solver.preconditioner
Preconditioners for iterative solvers.
cern.colt.matrix.tfloat.impl - package cern.colt.matrix.tfloat.impl
Efficient and flexible dense and sparse 1, 2 and 3-dimensional matrices holding elements of float data type.
cern.colt.matrix.tint - package cern.colt.matrix.tint
Matrix interfaces and factories holding elements of int data type.
cern.colt.matrix.tint.algo - package cern.colt.matrix.tint.algo
Algorithms operating on integer matrices.
cern.colt.matrix.tint.impl - package cern.colt.matrix.tint.impl
Efficient and flexible dense and sparse 1, 2 and 3-dimensional matrices holding elements of int data type.
cern.colt.matrix.tlong - package cern.colt.matrix.tlong
Matrix interfaces and factories holding elements of long data type.
cern.colt.matrix.tlong.algo - package cern.colt.matrix.tlong.algo
Algorithms operating on long integer matrices.
cern.colt.matrix.tlong.impl - package cern.colt.matrix.tlong.impl
Efficient and flexible dense and sparse 1, 2 and 3-dimensional matrices holding elements of long data type.
cern.colt.matrix.tobject - package cern.colt.matrix.tobject
Matrix interfaces and factories holding elements of Object data type.
cern.colt.matrix.tobject.algo - package cern.colt.matrix.tobject.algo
Object matrix algorithms such as print formatting, sorting, partitioning and statistics.
cern.colt.matrix.tobject.impl - package cern.colt.matrix.tobject.impl
Efficient and flexible dense and sparse 1, 2 and 3-dimensional matrices holding elements of Object data type.
cern.hep.aida.bin - package cern.hep.aida.bin
Multisets (bags) with efficient statistics operations defined upon; This package requires the Colt distribution.
cern.hep.aida.ref - package cern.hep.aida.ref
Reference implementation of the AIDA histogram interfaces.
cern.jet.math - package cern.jet.math
Tools for basic and advanced mathematics: Arithmetics and Algebra, Polynomials and Chebyshev series, Bessel and Airy functions, Function Objects for generic function evaluation, etc.
cern.jet.math.tdcomplex - package cern.jet.math.tdcomplex
Tools for basic and advanced mathematics: Arithmetics and Function Objects for generic function evaluation operating on dcomplex data type.
cern.jet.math.tdouble - package cern.jet.math.tdouble
Tools for basic and advanced mathematics: Arithmetics and Algebra, Polynomials and Chebyshev series, Bessel and Airy functions, Function Objects for generic function evaluation, etc.
cern.jet.math.tfcomplex - package cern.jet.math.tfcomplex
Tools for basic and advanced mathematics: Arithmetics and Function Objects for generic function evaluation operating on fcomplex data type.
cern.jet.math.tfloat - package cern.jet.math.tfloat
Tools for basic and advanced mathematics: Arithmetics and Function Objects for generic function evaluation operating on float data type.
cern.jet.math.tint - package cern.jet.math.tint
Tools for basic and advanced mathematics: Arithmetics and Function Objects for generic function evaluation operating on int data type.
cern.jet.math.tlong - package cern.jet.math.tlong
Tools for basic and advanced mathematics: Arithmetics and Function Objects for generic function evaluation operating on long data type.
cern.jet.random - package cern.jet.random
Large variety of probability distributions featuring high performance generation of random numbers, CDF's and PDF's.
cern.jet.random.engine - package cern.jet.random.engine
Engines generating strong uniformly distributed pseudo-random numbers; Needed by all JET probability distributions since they rely on uniform random numbers to generate random numbers from their own distribution.
cern.jet.random.sampling - package cern.jet.random.sampling
Samples (picks) random subsets of data sequences.
cern.jet.random.tdouble - package cern.jet.random.tdouble
Large variety of probability distributions featuring high performance generation of random numbers, CDF's and PDF's.
cern.jet.random.tdouble.engine - package cern.jet.random.tdouble.engine
Engines generating strong uniformly distributed pseudo-random numbers; Needed by all JET probability distributions since they rely on uniform random numbers to generate random numbers from their own distribution.
cern.jet.random.tdouble.sampling - package cern.jet.random.tdouble.sampling
Samples (picks) random subsets of data sequences.
cern.jet.random.tfloat - package cern.jet.random.tfloat
Large variety of probability distributions featuring high performance generation of random numbers, CDF's and PDF's.
cern.jet.random.tfloat.engine - package cern.jet.random.tfloat.engine
Engines generating strong uniformly distributed pseudo-random numbers; Needed by all JET probability distributions since they rely on uniform random numbers to generate random numbers from their own distribution.
cern.jet.random.tfloat.sampling - package cern.jet.random.tfloat.sampling
Samples (picks) random subsets of data sequences.
cern.jet.stat - package cern.jet.stat
Tools for basic and advanced statistics: Estimators, Gamma functions, Beta functions, Probabilities, Special integrals, etc.
cern.jet.stat.quantile - package cern.jet.stat.quantile
Scalable algorithms and data structures to compute approximate quantiles over very large data sequences.
cern.jet.stat.tdouble - package cern.jet.stat.tdouble
Tools for basic and advanced statistics: Estimators, Gamma functions, Beta functions, Probabilities, Special integrals, etc.
cern.jet.stat.tdouble.quantile - package cern.jet.stat.tdouble.quantile
Scalable algorithms and data structures to compute approximate quantiles over very large data sequences.
cern.jet.stat.tfloat - package cern.jet.stat.tfloat
Tools for basic and advanced statistics: Estimators, Gamma functions, Beta functions, Probabilities, Special integrals, etc.
cern.jet.stat.tfloat.quantile - package cern.jet.stat.tfloat.quantile
Scalable algorithms and data structures to compute approximate quantiles over very large data sequences.
cfd - Variable in class flanagan.analysis.LogNormalThreeParFunct
 
CGLSDoubleIterationMonitor - Class in cern.colt.matrix.tdouble.algo.solver
 
CGLSDoubleIterationMonitor() - Constructor for class cern.colt.matrix.tdouble.algo.solver.CGLSDoubleIterationMonitor
 
CGLSFloatIterationMonitor - Class in cern.colt.matrix.tfloat.algo.solver
 
CGLSFloatIterationMonitor() - Constructor for class cern.colt.matrix.tfloat.algo.solver.CGLSFloatIterationMonitor
 
chain(DoubleDoubleFunction, DoubleFunction, DoubleFunction) - Static method in class cern.jet.math.Functions
Constructs the function f( g(a), h(b) ).
chain(DoubleFunction, DoubleDoubleFunction) - Static method in class cern.jet.math.Functions
Constructs the function g( h(a,b) ).
chain(DoubleFunction, DoubleFunction) - Static method in class cern.jet.math.Functions
Constructs the function g( h(a) ).
chain(IntFunction, IntFunction) - Static method in class cern.jet.math.IntFunctions
Constructs the function g( h(a) ).
chain(IntFunction, IntIntFunction) - Static method in class cern.jet.math.IntFunctions
Constructs the function g( h(a,b) ).
chain(IntIntFunction, IntFunction, IntFunction) - Static method in class cern.jet.math.IntFunctions
Constructs the function f( g(a), h(b) ).
chain(DComplexDComplexDComplexFunction, DComplexDComplexFunction, DComplexDComplexFunction) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
chain(DComplexDComplexFunction, DComplexDComplexDComplexFunction) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
chain(DComplexDComplexFunction, DComplexDComplexFunction) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
chain(DoubleDoubleFunction, DoubleFunction, DoubleFunction) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs the function f( g(a), h(b) ).
chain(DoubleFunction, DoubleDoubleFunction) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs the function g( h(a,b) ).
chain(DoubleFunction, DoubleFunction) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs the function g( h(a) ).
chain(FComplexFComplexFComplexFunction, FComplexFComplexFunction, FComplexFComplexFunction) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
chain(FComplexFComplexFunction, FComplexFComplexFComplexFunction) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
chain(FComplexFComplexFunction, FComplexFComplexFunction) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
chain(FloatFloatFunction, FloatFunction, FloatFunction) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs the function f( g(a), h(b) ).
chain(FloatFunction, FloatFloatFunction) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs the function g( h(a,b) ).
chain(FloatFunction, FloatFunction) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs the function g( h(a) ).
chain(IntFunction, IntFunction) - Static method in class cern.jet.math.tint.IntFunctions
Constructs the function g( h(a) ).
chain(IntFunction, IntIntFunction) - Static method in class cern.jet.math.tint.IntFunctions
Constructs the function g( h(a,b) ).
chain(IntIntFunction, IntFunction, IntFunction) - Static method in class cern.jet.math.tint.IntFunctions
Constructs the function f( g(a), h(b) ).
chain(LongFunction, LongFunction) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs the function g( h(a) ).
chain(LongFunction, LongLongFunction) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs the function g( h(a,b) ).
chain(LongLongFunction, LongFunction, LongFunction) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs the function f( g(a), h(b) ).
ChainedTuple - Class in hep.aida.ref.tuple
 
ChainedTuple(String, String, ITuple[]) - Constructor for class hep.aida.ref.tuple.ChainedTuple
Tuple constructor.
CHANGE_DIRECTORY - Static variable in class hep.aida.ref.event.TreeEvent
 
changeCapacity(int) - Method in class umontreal.iro.lecuyer.simprocs.Resource
Modifies by diff units (increases if diff > 0, decreases if diff < 0) the capacity (i.e., the number of units) of the resource.
CharArrayList - Class in cern.colt.list
Resizable list holding char elements; implemented with arrays.
CharArrayList() - Constructor for class cern.colt.list.CharArrayList
Constructs an empty list.
CharArrayList(char[]) - Constructor for class cern.colt.list.CharArrayList
Constructs a list containing the specified elements.
CharArrayList(int) - Constructor for class cern.colt.list.CharArrayList
Constructs an empty list with the specified initial capacity.
CharArrayList - Class in cern.colt.list.tchar
Resizable list holding char elements; implemented with arrays.
CharArrayList() - Constructor for class cern.colt.list.tchar.CharArrayList
Constructs an empty list.
CharArrayList(char[]) - Constructor for class cern.colt.list.tchar.CharArrayList
Constructs a list containing the specified elements.
CharArrayList(int) - Constructor for class cern.colt.list.tchar.CharArrayList
Constructs an empty list with the specified initial capacity.
charAt(int) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
 
CharBuffer - Class in cern.colt.buffer.tchar
Fixed sized (non resizable) streaming buffer connected to a target CharBufferConsumer to which data is automatically flushed upon buffer overflow.
CharBuffer(CharBufferConsumer, int) - Constructor for class cern.colt.buffer.tchar.CharBuffer
Constructs and returns a new buffer with the given target.
CharBuffer2D - Class in cern.colt.buffer.tchar
Fixed sized (non resizable) streaming buffer connected to a target CharBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
CharBuffer2D(CharBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.tchar.CharBuffer2D
Constructs and returns a new buffer with the given target.
CharBuffer2DConsumer - Interface in cern.colt.buffer.tchar
Target of a streaming CharBuffer2D into which data is flushed upon buffer overflow.
CharBuffer3D - Class in cern.colt.buffer.tchar
Fixed sized (non resizable) streaming buffer connected to a target CharBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
CharBuffer3D(CharBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.tchar.CharBuffer3D
Constructs and returns a new buffer with the given target.
CharBuffer3DConsumer - Interface in cern.colt.buffer.tchar
Target of a streaming CharBuffer3D into which data is flushed upon buffer overflow.
CharBufferConsumer - Interface in cern.colt.buffer.tchar
Target of a streaming CharBuffer into which data is flushed upon buffer overflow.
CharComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
CharComparator - Interface in cern.colt.function.tchar
A comparison function which imposes a total ordering on some collection of elements.
CharProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
CharProcedure - Interface in cern.colt.function.tchar
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
chbevl(double, double[], int) - Static method in class cern.jet.math.Arithmetic
Evaluates the series of Chebyshev polynomials Ti at argument x/2.
chbevl(double, double[], int) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Evaluates the series of Chebyshev polynomials Ti at argument x/2.
chbevl(float, float[], int) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Evaluates the series of Chebyshev polynomials Ti at argument x/2.
checkAdditionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math.linear.MatrixUtils
Check if matrices are addition compatible
checkBST() - Method in class flanagan.math.TimeAndDate
 
checkColumnDimension(double[][], int) - Static method in class jhplot.math.DoubleArray
Checks to make sure each row of a matrix is of a specified dimension.
checkColumnIndex(AnyMatrix, int) - Static method in class org.apache.commons.math.linear.MatrixUtils
Check if a column index is valid.
checkDense(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
 
checkDense(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
 
checkDense(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
 
checkDense(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
 
checkForChildren(String) - Method in class hep.aida.ref.tree.Tree
This message is sent by a listener to indicate interest in a particular path within the tree.
checkForIdenticalPoints() - Method in class flanagan.interpolation.CubicSpline
 
checkIntegerTimesPowerOfTwo(int) - Static method in class flanagan.math.FourierTransform
 
checkLength(double[], int) - Static method in class jhplot.math.DoubleArray
Checks to make sure an array is of a specified length.
checkMultiplicationCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math.linear.MatrixUtils
Check if matrices are multiplication compatible
checkOrder(double[], MathUtils.OrderDirection, boolean) - Static method in class org.apache.commons.math.util.MathUtils
Checks that the given array is sorted.
checkOrder(double[]) - Static method in class org.apache.commons.math.util.MathUtils
Checks that the given array is sorted in strictly increasing order.
checkOrder(double[], int, boolean) - Static method in class org.apache.commons.math.util.MathUtils
Deprecated. as of 2.2 (please use the new checkOrder method). To be removed in 3.0.
checkPowerOfTwo(int) - Static method in class flanagan.math.FourierTransform
 
checkRectangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Checks whether the given matrix A is rectangular.
checkRectangular(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Checks whether the given matrix A is rectangular.
checkRectangular(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Checks whether the given matrix A is rectangular.
checkRectangular(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
Checks whether the given matrix A is rectangular.
checkRectangular(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Checks whether the given matrix A is rectangular.
checkRowDimension(double[][], int) - Static method in class jhplot.math.DoubleArray
Checks to make sure each column of a matrix is of a specified dimension.
checkRowIndex(AnyMatrix, int) - Static method in class org.apache.commons.math.linear.MatrixUtils
Check if a row index is valid.
checkShape(AbstractMatrix2D) - Method in class cern.colt.matrix.AbstractMatrix2D
Sanity check for operations requiring two matrices with the same number of columns and rows.
checkShape(AbstractMatrix2D, AbstractMatrix2D) - Method in class cern.colt.matrix.AbstractMatrix2D
Sanity check for operations requiring matrices with the same number of columns and rows.
checkShape(AbstractMatrix3D) - Method in class cern.colt.matrix.AbstractMatrix3D
Sanity check for operations requiring two matrices with the same number of slices, rows and columns.
checkShape(AbstractMatrix3D, AbstractMatrix3D) - Method in class cern.colt.matrix.AbstractMatrix3D
Sanity check for operations requiring matrices with the same number of slices, rows and columns.
checkShape(AbstractMatrix2D) - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Sanity check for operations requiring two matrices with the same number of columns and rows.
checkShape(AbstractMatrix2D, AbstractMatrix2D) - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Sanity check for operations requiring matrices with the same number of columns and rows.
checkShape(AbstractMatrix3D) - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Sanity check for operations requiring two matrices with the same number of slices, rows and columns.
checkShape(AbstractMatrix3D, AbstractMatrix3D) - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Sanity check for operations requiring matrices with the same number of slices, rows and columns.
checkSize(AbstractMatrix1D) - Method in class cern.colt.matrix.AbstractMatrix1D
Sanity check for operations requiring two matrices with the same size.
checkSize(AbstractMatrix1D) - Method in class cern.colt.matrix.impl.AbstractMatrix1D
Sanity check for operations requiring two matrices with the same size.
checkSparse(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
 
checkSparse(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
 
checkSparse(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
 
checkSparse(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
 
checkSquare(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Checks whether the given matrix A is square.
checkSquare(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Checks whether the given matrix A is square.
checkSquare(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Checks whether the given matrix A is square.
checkSquare(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
Checks whether the given matrix A is square.
checkSquare(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Checks whether the given matrix A is square.
checkSubMatrixIndex(AnyMatrix, int, int, int, int) - Static method in class org.apache.commons.math.linear.MatrixUtils
Check if submatrix ranges indices are valid.
checkSubMatrixIndex(AnyMatrix, int[], int[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Check if submatrix ranges indices are valid.
checkSubtractionCompatible(AnyMatrix, AnyMatrix) - Static method in class org.apache.commons.math.linear.MatrixUtils
Check if matrices are subtraction compatible
checkYallSmall(double, String) - Method in class flanagan.analysis.Regression
 
checkZeroNeg(double[], double[], double[]) - Method in class flanagan.analysis.Regression
 
chi2(int) - Static method in class jhplot.math.Random
Generate a random number from a Chi-2 random variable.
chi2(double[], int[], int, int) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Computes and returns the chi-square statistic for the observations oi in count[smin...smax], for which the corresponding expected values ei are in nbExp[smin...smax].
chi2(IntArrayList, DiscreteDistributionInt, int, int, double, int[]) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Computes and returns the chi-square statistic for the observations stored in data, assuming that these observations follow the discrete distribution dist.
chi2Equal(double, int[], int, int) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Similar to chi2, except that the expected number of observations per category is assumed to be the same for all categories, and equal to nbExp.
chi2Equal(DoubleArrayList, double) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Computes the chi-square statistic for a continuous distribution.
chi2Equal(DoubleArrayList) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Equivalent to chi2Equal (data, 10).
ChiDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the chi distribution with shape parameter v > 0, where the number of degrees of freedom v is a positive integer.
ChiDist(int) - Constructor for class umontreal.iro.lecuyer.probdist.ChiDist
Constructs a ChiDist object.
ChiGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the chi distribution.
ChiGen(RandomStream, int) - Constructor for class umontreal.iro.lecuyer.randvar.ChiGen
Creates a chi random variate generator with ν = nu degrees of freedom, using stream s.
ChiGen(RandomStream, ChiDist) - Constructor for class umontreal.iro.lecuyer.randvar.ChiGen
Create a new generator for the distribution dist, using stream s.
ChiRatioOfUniformsGen - Class in umontreal.iro.lecuyer.randvar
This class implements Chi random variate generators using the ratio of uniforms method with shift.
ChiRatioOfUniformsGen(RandomStream, int) - Constructor for class umontreal.iro.lecuyer.randvar.ChiRatioOfUniformsGen
Creates a chi random variate generator with ν = nu degrees of freedom, using stream s.
ChiRatioOfUniformsGen(RandomStream, ChiDist) - Constructor for class umontreal.iro.lecuyer.randvar.ChiRatioOfUniformsGen
Create a new generator for the distribution dist, using stream s.
ChiSquare - Class in cern.jet.random
ChiSquare distribution; See the math definition and animated definition.
ChiSquare(double, RandomEngine) - Constructor for class cern.jet.random.ChiSquare
Constructs a ChiSquare distribution.
ChiSquare - Class in cern.jet.random.tdouble
ChiSquare distribution; See the math definition and animated definition.
ChiSquare(double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.ChiSquare
Constructs a ChiSquare distribution.
chiSquare(double, double) - Static method in class cern.jet.stat.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.
chiSquare(double, double) - Static method in class cern.jet.stat.tdouble.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.
chiSquare(double[], double[], double[]) - Static method in class flanagan.analysis.Stat
 
chiSquare(double[], long[]) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Computes the Chi-Square statistic comparing observed and expected frequency counts.
chiSquare(long[][]) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Computes the Chi-Square statistic associated with a chi-square test of independence based on the input counts array, viewed as a two-way table.
chiSquare(double[], long[]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Computes the Chi-Square statistic comparing observed and expected frequency counts.
chiSquare(long[][]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquare(double[], long[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquare(long[][]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareArray(int, int) - Method in class flanagan.math.PsRandom
 
chiSquareCDF(double, int) - Static method in class flanagan.analysis.Stat
 
chiSquareComplemented(double, double) - Static method in class cern.jet.stat.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.
chiSquareComplemented(double, double) - Static method in class cern.jet.stat.tdouble.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.
ChiSquared - Class in jhplot.math.num.pdf
The Chi-Squared distribution (1).
ChiSquared() - Constructor for class jhplot.math.num.pdf.ChiSquared
Default constructor.
ChiSquared(double) - Constructor for class jhplot.math.num.pdf.ChiSquared
Create a distribution with the given degrees of freedom.
chiSquareDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquareDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareDataSetsComparison(long[], long[]) - Method in interface org.apache.commons.math.stat.inference.UnknownDistributionChiSquareTest
Computes a Chi-Square two sample test statistic comparing bin frequency counts in observed1 and observed2.
ChiSquaredDistribution - Interface in org.apache.commons.math.distribution
The Chi-Squared Distribution.
ChiSquaredDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of ChiSquaredDistribution
ChiSquaredDistributionImpl(double) - Constructor for class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Create a Chi-Squared distribution with the given degrees of freedom.
ChiSquaredDistributionImpl(double, GammaDistribution) - Constructor for class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Deprecated. as of 2.1 (to avoid possibly inconsistent state, the "GammaDistribution" will be instantiated internally)
ChiSquaredDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Create a Chi-Squared distribution with the given degrees of freedom and inverse cumulative probability accuracy.
ChiSquaredFitMethod - Class in hep.aida.ref.fitter.fitmethod
 
ChiSquaredFitMethod() - Constructor for class hep.aida.ref.fitter.fitmethod.ChiSquaredFitMethod
 
ChiSquareDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the chi-square distribution with n degrees of freedom, where n is a positive integer.
ChiSquareDist(int) - Constructor for class umontreal.iro.lecuyer.probdist.ChiSquareDist
Constructs a chi-square distribution with n degrees of freedom.
ChiSquareDistQuick - Class in umontreal.iro.lecuyer.probdist
Provides a variant of ChiSquareDist with faster but less accurate methods.
ChiSquareDistQuick(int) - Constructor for class umontreal.iro.lecuyer.probdist.ChiSquareDistQuick
Constructs a chi-square distribution with n degrees of freedom.
ChiSquaredRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Chi-Squared distribution.
ChiSquaredRandomVariable() - Constructor for class jhplot.math.num.random.ChiSquaredRandomVariable
Default constructor.
ChiSquaredRandomVariable(double) - Constructor for class jhplot.math.num.random.ChiSquaredRandomVariable
Create a random variable with the given degrees of freedom.
ChiSquaredRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.ChiSquaredRandomVariable
Create a random variable with the given parameters.
chiSquareFreq(double[], double[]) - Static method in class flanagan.analysis.Stat
 
chiSquareFreq(int[], int[]) - Static method in class flanagan.analysis.Stat
 
ChiSquareGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators with the chi square distribution with n > 0 degrees of freedom.
ChiSquareGen(RandomStream, int) - Constructor for class umontreal.iro.lecuyer.randvar.ChiSquareGen
Creates a chi square random variate generator with n degrees of freedom, using stream s.
ChiSquareGen(RandomStream, ChiSquareDist) - Constructor for class umontreal.iro.lecuyer.randvar.ChiSquareGen
Create a new generator for the distribution dist and stream s.
chiSquareMean(int) - Static method in class flanagan.analysis.Stat
 
chiSquareMode(int) - Static method in class flanagan.analysis.Stat
 
ChiSquareNoncentralDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the noncentral chi-square distribution with ν degrees of freedom and noncentrality parameter λ, where ν > 0 and λ > 0.
ChiSquareNoncentralDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Constructs a noncentral chi-square distribution with ν = nu degrees of freedom and noncentrality parameter λ = lambda.
ChiSquareNoncentralGamGen - Class in umontreal.iro.lecuyer.randvar
This class implements noncentral chi square random variate generators using the additive property of the noncentral chi square distribution.
ChiSquareNoncentralGamGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralGamGen
Creates a noncentral chi square random variate generator with with ν = nu degrees of freedom and noncentrality parameter λ = lambda using stream stream, as described above.
ChiSquareNoncentralGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the noncentral chi square distribution with ν degrees of freedom and noncentrality parameter λ.
ChiSquareNoncentralGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralGen
Creates a noncentral chi square random variate generator with ν > 0 degrees of freedom and noncentrality parameter λ > 0, using stream s.
ChiSquareNoncentralGen(RandomStream, ChiSquareNoncentralDist) - Constructor for class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralGen
Create a new generator for the distribution dist and stream s.
ChiSquareNoncentralPoisGen - Class in umontreal.iro.lecuyer.randvar
This class implements noncentral chi square random variate generators using Poisson and central chi square generators.
ChiSquareNoncentralPoisGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralPoisGen
Creates a noncentral chi square random variate generator with ν = nu degrees of freedom and noncentrality parameter λ = lambda using stream stream, as described above.
chiSquarePDF(double, int) - Static method in class flanagan.analysis.Stat
 
chiSquareProb(double, int) - Static method in class flanagan.analysis.Stat
 
chiSquareRand(int, int) - Static method in class flanagan.analysis.Stat
 
chiSquareRand(int, int, long) - Static method in class flanagan.analysis.Stat
 
chiSquareStandardDeviation(int) - Static method in class flanagan.analysis.Stat
 
chiSquareStandDev(int) - Static method in class flanagan.analysis.Stat
 
ChiSquareTest - Interface in org.apache.commons.math.stat.inference
An interface for Chi-Square tests.
chiSquareTest(double[], long[]) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Returns the observed significance level, or p-value, associated with a Chi-square goodness of fit test comparing the observed frequency counts to those in the expected array.
chiSquareTest(double[], long[], double) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Performs a Chi-square goodness of fit test evaluating the null hypothesis that the observed counts conform to the frequency distribution described by the expected counts, with significance level alpha.
chiSquareTest(long[][]) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Returns the observed significance level, or p-value, associated with a chi-square test of independence based on the input counts array, viewed as a two-way table.
chiSquareTest(long[][], double) - Method in interface org.apache.commons.math.stat.inference.ChiSquareTest
Performs a chi-square test of independence evaluating the null hypothesis that the classifications represented by the counts in the columns of the input 2-way table are independent of the rows, with significance level alpha.
chiSquareTest(double[], long[]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Returns the observed significance level, or p-value, associated with a Chi-square goodness of fit test comparing the observed frequency counts to those in the expected array.
chiSquareTest(double[], long[], double) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Performs a Chi-square goodness of fit test evaluating the null hypothesis that the observed counts conform to the frequency distribution described by the expected counts, with significance level alpha.
chiSquareTest(long[][]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquareTest(long[][], double) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquareTest(double[], long[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTest(double[], long[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTest(long[][], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTest(long[][]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTestDataSetsComparison(long[], long[]) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquareTestDataSetsComparison(long[], long[], double) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
 
chiSquareTestDataSetsComparison(long[], long[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTestDataSetsComparison(long[], long[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
chiSquareTestDataSetsComparison(long[], long[]) - Method in interface org.apache.commons.math.stat.inference.UnknownDistributionChiSquareTest
Returns the observed significance level, or p-value, associated with a Chi-Square two sample test comparing bin frequency counts in observed1 and observed2.
chiSquareTestDataSetsComparison(long[], long[], double) - Method in interface org.apache.commons.math.stat.inference.UnknownDistributionChiSquareTest
Performs a Chi-Square two sample test comparing two binned data sets.
ChiSquareTestImpl - Class in org.apache.commons.math.stat.inference
Implements Chi-Square test statistics defined in the UnknownDistributionChiSquareTest interface.
ChiSquareTestImpl() - Constructor for class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Construct a ChiSquareTestImpl
ChiSquareTestImpl(ChiSquaredDistribution) - Constructor for class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Create a test instance using the given distribution for computing inference statistics.
chol(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Constructs and returns the cholesky-decomposition of the given matrix.
chol(DoubleMatrix2D, int) - Method in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Constructs and returns the Cholesky-decomposition of the given matrix.
chol(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Constructs and returns the cholesky-decomposition of the given matrix.
chol(FloatMatrix2D, int) - Method in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Constructs and returns the Cholesky-decomposition of the given matrix.
cholesky(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
CholeskyDecompose(double[][], double[][]) - Static method in class umontreal.iro.lecuyer.util.DMatrix
Given a symmetric positive-definite matrix M, performs the Cholesky decomposition of M and returns the result as a lower triangular matrix L, such that M = LLT.
CholeskyDecompose(DoubleMatrix2D) - Static method in class umontreal.iro.lecuyer.util.DMatrix
Given a symmetric positive-definite matrix M, performs the Cholesky decomposition of M and returns the result as a lower triangular matrix L, such that M = LLT.
CholeskyDecomposition - Class in cern.colt.matrix.linalg
For a symmetric, positive definite matrix A, the Cholesky decomposition is a lower triangular matrix L so that A = L*L'; If the matrix is not symmetric or positive definite, the constructor returns a partial decomposition and sets an internal flag that may be queried by the isSymmetricPositiveDefinite() method.
CholeskyDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.linalg.CholeskyDecomposition
Constructs and returns a new Cholesky decomposition object for a symmetric and positive definite matrix; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
CholeskyDecomposition - Class in jhplot.math
Cholesky Decomposition.
CholeskyDecomposition(double[][]) - Constructor for class jhplot.math.CholeskyDecomposition
Cholesky algorithm for symmetric and positive definite matrix.
CholeskyDecomposition - Interface in org.apache.commons.math.linear
An interface to classes that implement an algorithm to calculate the Cholesky decomposition of a real symmetric positive-definite matrix.
CholeskyDecompositionImpl - Class in org.apache.commons.math.linear
Calculates the Cholesky decomposition of a matrix.
CholeskyDecompositionImpl(RealMatrix) - Constructor for class org.apache.commons.math.linear.CholeskyDecompositionImpl
Calculates the Cholesky decomposition of the given matrix.
CholeskyDecompositionImpl(RealMatrix, double, double) - Constructor for class org.apache.commons.math.linear.CholeskyDecompositionImpl
Calculates the Cholesky decomposition of the given matrix.
christmasDay() - Method in class flanagan.math.TimeAndDate
 
christmasDay(int) - Method in class flanagan.math.TimeAndDate
 
Chromosome - Class in org.apache.commons.math.genetics
Individual in a population.
Chromosome() - Constructor for class org.apache.commons.math.genetics.Chromosome
 
ChromosomePair - Class in org.apache.commons.math.genetics
A pair of Chromosome objects.
ChromosomePair(Chromosome, Chromosome) - Constructor for class org.apache.commons.math.genetics.ChromosomePair
Create a chromosome pair.
Chrono - Class in umontreal.iro.lecuyer.util
The Chrono class extends the AbstractChrono class and computes the CPU time for the current thread only.
Chrono() - Constructor for class umontreal.iro.lecuyer.util.Chrono
Constructs a Chrono object and initializes it to zero.
ChronoSingleThread - Class in umontreal.iro.lecuyer.util
Deprecated. 
ChronoSingleThread() - Constructor for class umontreal.iro.lecuyer.util.ChronoSingleThread
Deprecated. Constructs a ChronoSingleThread object and initializes it to zero.
chs() - Method in class jhplot.math.Complex
Negative of this complex number (chs stands for change sign).
Circle - Class in jhplot.shapes
Build a Circle using the USER coordinate system
Circle(double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.Circle
Build a circle
Circle(double, double, double) - Constructor for class jhplot.shapes.Circle
Build a circle using the default stroke and color
CIRCLE - Static variable in class jhplot.shapes.HShape
 
CIRProcess - Class in umontreal.iro.lecuyer.stochprocess
This class represents a CIR (Cox, Ingersoll, Ross) process {X(t) : t >= 0}, sampled at times 0 = t0 < t1 < ...
CIRProcess(double, double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.CIRProcess
Constructs a new CIRProcess with parameters α = alpha, b, σ = sigma and initial value X(t0) = x0.
CIRProcess(double, double, double, double, ChiSquareNoncentralGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.CIRProcess
The noncentral chi-square variate generator gen is specified directly instead of specifying the stream.
CIRProcessEuler - Class in umontreal.iro.lecuyer.stochprocess
.
CIRProcessEuler(double, double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
Constructs a new CIRProcessEuler with parameters α = alpha, b, σ = sigma and initial value X(t0) = x0.
CIRProcessEuler(double, double, double, double, NormalGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
The normal variate generator gen is specified directly instead of specifying the stream.
classes() - Method in class org.apache.commons.math.util.TransformerMap
Returns the Set of Classes used as keys in the map.
ClassFinder - Class in umontreal.iro.lecuyer.util
Utility class used to convert a simple class name to a fully qualified class object.
ClassFinder() - Constructor for class umontreal.iro.lecuyer.util.ClassFinder
Constructs a new class finder with an empty list of import declarations.
classic_electr_radius - Static variable in class cern.clhep.PhysicalConstants
 
ClassicalRungeKuttaIntegrator - Class in org.apache.commons.math.ode.nonstiff
This class implements the classical fourth order Runge-Kutta integrator for Ordinary Differential Equations (it is the most often used Runge-Kutta method).
ClassicalRungeKuttaIntegrator(double) - Constructor for class org.apache.commons.math.ode.nonstiff.ClassicalRungeKuttaIntegrator
Simple constructor.
classify() - Method in class org.apache.commons.math.dfp.Dfp
Returns the type - one of FINITE, INFINITE, SNAN, QNAN.
clear() - Method in class cern.colt.bitvector.BitMatrix
Clears all bits of the receiver.
clear() - Method in class cern.colt.bitvector.BitVector
Clears all bits of the receiver.
clear(int) - Method in class cern.colt.bitvector.BitVector
Changes the bit with index bitIndex to the "clear" (false) state.
clear(long[], int) - Static method in class cern.colt.bitvector.QuickBitVector
Changes the bit with index bitIndex in the bitvector bits to the "clear" (false) state.
clear() - Method in class cern.colt.buffer.DoubleBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.DoubleBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.DoubleBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.IntBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.IntBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.IntBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.ObjectBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tboolean.BooleanBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tboolean.BooleanBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tboolean.BooleanBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tbyte.ByteBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tbyte.ByteBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tbyte.ByteBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tchar.CharBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tchar.CharBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tchar.CharBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tdouble.DoubleBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tdouble.DoubleBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tdouble.DoubleBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tfloat.FloatBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tfloat.FloatBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tfloat.FloatBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tint.IntBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tint.IntBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tint.IntBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tlong.LongBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tlong.LongBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tlong.LongBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tobject.ObjectBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tshort.ShortBuffer
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tshort.ShortBuffer2D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.buffer.tshort.ShortBuffer3D
Sets the receiver's size to zero.
clear() - Method in class cern.colt.list.AbstractCollection
Removes all elements from the receiver.
clear() - Method in class cern.colt.list.AbstractList
Removes all elements from the receiver.
clear() - Method in class cern.colt.map.AbstractMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.OpenDoubleIntHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.OpenIntDoubleHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.OpenIntIntHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.OpenIntObjectHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.OpenLongObjectHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tint.OpenIntIntHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Removes all (key,value) associations from the receiver.
clear() - Method in class cern.colt.matrix.tbit.BitMatrix
Clears all bits of the receiver.
clear() - Method in class cern.colt.matrix.tbit.BitVector
Clears all bits of the receiver.
clear(int) - Method in class cern.colt.matrix.tbit.BitVector
Changes the bit with index bitIndex to the "clear" ( false) state.
clear(long[], int) - Static method in class cern.colt.matrix.tbit.QuickBitVector
Changes the bit with index bitIndex in the bitvector bits to the "clear" (false) state.
clear() - Method in class cern.hep.aida.bin.AbstractBin
Removes all elements from the receiver.
clear() - Method in class cern.hep.aida.bin.DynamicBin1D
Removes all elements from the receiver.
clear() - Method in class cern.hep.aida.bin.QuantileBin1D
Removes all elements from the receiver.
clear() - Method in class cern.hep.aida.bin.StaticBin1D
Removes all elements from the receiver.
clear() - Method in class cern.jet.stat.Buffer
Clears the receiver.
clear() - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Removes all elements from the receiver.
clear() - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Clears the receiver.
clear() - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Removes all elements from the receiver.
clear() - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Removes all elements from the receiver.
clear() - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Removes all elements from the receiver.
clear() - Method in class hep.aida.ref.fitter.fitmethod.AbstractFitMethod
 
clear() - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
clear() - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
clear() - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
clear() - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
clear() - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
clear() - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
clear() - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner1D
 
clear() - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
clear() - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
clear() - Method in class hep.aida.ref.histogram.DataPoint
 
clear() - Method in class hep.aida.ref.histogram.DataPointSet
 
clear() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Removes all elements from the receiver.
clear() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Removes all elements from the receiver.
clear() - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Removes all elements from the receiver.
clear() - Method in class hep.aida.tdouble.bin.StaticDoubleBin1D
Removes all elements from the receiver.
clear() - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Removes all elements from the receiver.
clear() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Removes all elements from the receiver.
clear() - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Removes all elements from the receiver.
clear() - Method in class hep.aida.tfloat.bin.StaticFloatBin1D
Removes all elements from the receiver.
clear() - Method in class jhplot.H1D
Make a copy of the data holder
clear() - Method in class jhplot.H2D
 
clear() - Method in class jhplot.HBook
Remove all objects from the HBook
clear() - Method in class jhplot.HChart
Clear the current graph including graph settings.
clear(int, int) - Method in class jhplot.HChart
Clear the chart characterized by an index in X and Y.
clear() - Method in class jhplot.HGraph
Clear the current graph including graph settings.
clear(int, int) - Method in class jhplot.HGraph
Clear the graph characterized by an index in X and Y.
clear() - Method in class jhplot.HPlot
Clear the current graph including graph settings.
clear(int, int) - Method in class jhplot.HPlot
Clear the graph characterised by an index in X and Y.
clear() - Method in class jhplot.HPlot2D
Clear the current pad
clear() - Method in class jhplot.HPlot3D
Clear the current graph including graph settings.
clear(int, int) - Method in class jhplot.HPlot3D
Clear the graph characterized by an index in X and Y.
clear() - Method in class jhplot.HPlot3DP
Clear the current graph including graph settings.
clear(int, int) - Method in class jhplot.HPlot3DP
Clear the graph characterized by an index in X and Y.
clear() - Method in class jhplot.HView3D
Clear the current graph including graph settings.
clear(int, int) - Method in class jhplot.HView3D
Clear the graph characterized by an index in X and Y.
clear() - Method in class jhplot.HZirkel
Clear the canvas
clear() - Method in class jhplot.jadraw.JaAxes
Clear.
clear() - Method in class jhplot.math.num.DoubleArray
Remove all elements from this collection.
clear() - Method in class jhplot.P0D
Clear the container
clear() - Method in class jhplot.P0I
Clear the container
clear() - Method in class jhplot.P1D
Clear the container
clear() - Method in class jhplot.P2D
Clear the container
clear() - Method in class jhplot.P3D
Clear the container
clear() - Method in class jhplot.PND
Clear the container
clear() - Method in class jhplot.PNI
Clear the container
clear() - Method in class jhplot.SPlot
Clear the plot of all data points.
clear(int) - Method in class jhplot.SPlot
Clear the plot of data points in the specified dataset.
clear() - Method in class jminhep.cluster.DataHolder
Clear current data holder
clear() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Clears the cache used by the default implementation of AbstractRandomGenerator.nextGaussian().
clear() - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.FourthMoment
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.SecondMoment
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math.stat.descriptive.rank.Max
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.rank.Min
Clears the internal state of the Statistic
clear() - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.summary.Product
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Clears the internal state of the Statistic
clear() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Resets all statistics and storage
clear() - Method in class org.apache.commons.math.stat.Frequency
Clears the frequency table
clear() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Clears all data from the model.
clear() - Method in interface org.apache.commons.math.util.DoubleArray
Clear the double array
clear() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Clear the array, reset the size to the initialCapacity and the number of elements to zero.
clear() - Method in class org.apache.commons.math.util.TransformerMap
Clears all the Class to Transformer mappings.
clear() - Method in class umontreal.iro.lecuyer.rng.RandomStreamManager
Removes all the streams from the internal list of this random stream manager.
clear() - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
clear() - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
clear() - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Empties the event list, i.e., cancels all events.
clear() - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
clear() - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
clear() - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
clear() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
 
clear() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
clear() - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Clears the contents of the buffer.
clear() - Method in class umontreal.iro.lecuyer.util.TransformingList
 
clearAll() - Method in class jhplot.HChart
Clear all graphs from data and settings.
clearAll() - Method in class jhplot.HGraph
Clear all graphs from data and settings.
clearAll() - Method in class jhplot.HPlot
Clear all graphs from data and settings.
clearAll() - Method in class jhplot.HPlot2D
Clear all pads
clearAll() - Method in class jhplot.HPlot3D
Clear all graphs from data and settings.
clearAll() - Method in class jhplot.HPlot3DP
Clear all graphs from data and settings.
clearAll() - Method in class jhplot.HPlotJa
Clear the canvas from all objects
clearAll() - Method in class jhplot.HView3D
Clear all graphs from data and settings.
clearAllData() - Method in class jhplot.HPlot
Clear all graphs from the input data.
clearAllData() - Method in class jhplot.HPlotJa
Clear all data from all graphs.
clearAllLabels() - Method in class jhplot.HPlot
Clear all graph labels
clearArrayOfObservationListeners() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Removes all observation listeners from the list of observers of this list of statistical probes.
clearCache() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Clears the cached values for this cached generator.
clearCache() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Clears the cached values for this random stream.
clearData() - Method in class jhplot.HChart
Clear plot from the data
clearData() - Method in class jhplot.HPlot
Clear the current graph from the input data.
clearData(int, int) - Method in class jhplot.HPlot
Clear data of the graph characterised by an index in X and Y.
clearData(int) - Method in class jhplot.HPlot
Remove one data set from the current plot.
clearData(int, int) - Method in class jhplot.HPlotJa
Clear the axis frame from the data
clearData() - Method in class jhplot.HPlotJa
Clear the axis frame from the data for the current pad.
clearEventHandlers() - Method in class org.apache.commons.math.ode.AbstractIntegrator
Remove all the event handlers that have been added to the integrator.
clearEventHandlers() - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Remove all the event handlers that have been added to the integrator.
clearEventHandlers() - Method in interface org.apache.commons.math.ode.ODEIntegrator
Remove all the event handlers that have been added to the integrator.
clearEventsHandlers() - Method in class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Remove all the events handlers that have been added to the manager.
clearIEEEFlags() - Method in class org.apache.commons.math.dfp.DfpField
Clears the IEEE 854 status flags.
clearLabels() - Method in class jhplot.HPlot
Clear graph labels for the curent graph.
clearLabels(int, int) - Method in class jhplot.HPlot
Clear Graph settings including labels.
clearLegends() - Method in class jhplot.SPlot
Clear all legends.
clearObservable() - Method in class hep.aida.ref.event.ObserverAdapter
 
clearObservationListeners() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Removes all observation listeners from the list of observers of this statistical probe.
clearObservations() - Method in class org.apache.commons.math.optimization.fitting.CurveFitter
Remove all observations.
clearObservations() - Method in class org.apache.commons.math.optimization.fitting.PolynomialFitter
Remove all observations.
clearPlot() - Method in class jhplot.HChart
Clear plot.
clearRandomShift() - Method in class umontreal.iro.lecuyer.hups.ContainerPointSet
Calls clearRandomShift() of the contained point set.
clearRandomShift() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet
 
clearRandomShift() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2
 
clearRandomShift() - Method in class umontreal.iro.lecuyer.hups.DigitalNet
 
clearRandomShift() - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
clearRandomShift() - Method in class umontreal.iro.lecuyer.hups.PointSet
Erases the current random shift, if any.
clearRandomShift() - Method in class umontreal.iro.lecuyer.hups.Rank1Lattice
Clears the random shift.
clearStepHandlers() - Method in class org.apache.commons.math.ode.AbstractIntegrator
Remove all the step handlers that have been added to the integrator.
clearStepHandlers() - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Remove all the step handlers that have been added to the integrator.
clearStepHandlers() - Method in interface org.apache.commons.math.ode.ODEIntegrator
Remove all the step handlers that have been added to the integrator.
CleverChiSquaredFitMethod - Class in hep.aida.ref.fitter.fitmethod
 
CleverChiSquaredFitMethod() - Constructor for class hep.aida.ref.fitter.fitmethod.CleverChiSquaredFitMethod
 
CLimits - Class in jhpro.stat
Algorithm to compute 95% CL limits using the Likelihood ratio semi-Bayesian method.
CLimits(DataSource, int) - Constructor for class jhpro.stat.CLimits
Main constructor.
CLimits(DataSource, int, boolean) - Constructor for class jhpro.stat.CLimits
Main constructor.
CLimits(H1D, H1D, H1D, int) - Constructor for class jhpro.stat.CLimits
Get limits including statistical errors in the calculations.
CLimits(P1D, P1D, P1D, int) - Constructor for class jhpro.stat.CLimits
Initialize limit calculations including statistical errors in the calculations.
CLimits(H1D, H1D, H1D, double, double, double, String, int) - Constructor for class jhpro.stat.CLimits
Initialize limit calculations for one channel with systematic errors.
ClipBoardPrintable - Interface in jhplot.math.io
BSD License
clone() - Method in class cern.colt.bitvector.BitMatrix
Cloning this BitMatrix produces a new BitMatrix that is equal to it.
clone() - Method in class cern.colt.bitvector.BitVector
Cloning this BitVector produces a new BitVector that is equal to it.
clone() - Method in class cern.colt.list.AbstractBooleanList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractByteList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractCharList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractDoubleList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractFloatList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractIntList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractLongList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.AbstractShortList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.BooleanArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.ByteArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.CharArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.DoubleArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.FloatArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.IntArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.LongArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.ObjectArrayList
Returns a copy of the receiver such that the copy and the receiver share the same elements, but do not share the same array to index them; So modifying an object in the copy modifies the object in the receiver and vice versa; However, structurally modifying the copy (for example changing its size, setting other objects at indexes, etc.) does not affect the receiver and vice versa.
clone() - Method in class cern.colt.list.ShortArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tboolean.BooleanArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tbyte.AbstractByteList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tbyte.ByteArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tchar.AbstractCharList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tchar.CharArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tdouble.DoubleArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tfloat.FloatArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tint.AbstractIntList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tint.IntArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tlong.AbstractLongList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tlong.LongArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tobject.ObjectArrayList
Returns a copy of the receiver such that the copy and the receiver share the same elements, but do not share the same array to index them; So modifying an object in the copy modifies the object in the receiver and vice versa; However, structurally modifying the copy (for example changing its size, setting other objects at indexes, etc.) does not affect the receiver and vice versa.
clone() - Method in class cern.colt.list.tshort.AbstractShortList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.list.tshort.ShortArrayList
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.OpenDoubleIntHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.OpenIntDoubleHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.OpenIntIntHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.OpenIntObjectHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.OpenLongObjectHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tint.OpenIntIntHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Returns a deep copy of the receiver.
clone() - Method in class cern.colt.matrix.linalg.Algebra
Returns a copy of the receiver.
clone() - Method in class cern.colt.matrix.tbit.BitMatrix
Cloning this BitMatrix produces a new BitMatrix that is equal to it.
clone() - Method in class cern.colt.matrix.tbit.BitVector
Cloning this BitVector produces a new BitVector that is equal to it.
clone() - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns a copy of the receiver.
clone() - Method in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Returns a copy of the receiver.
clone() - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns a copy of the receiver.
clone() - Method in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Returns a copy of the receiver.
clone() - Method in class cern.colt.PersistentObject
Returns a copy of the receiver.
clone() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns a deep copy of the receiver.
clone() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns a deep copy of the receiver.
clone() - Method in class cern.hep.aida.bin.QuantileBin1D
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.AbstractDistribution
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.BreitWignerMeanSquare
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.Empirical
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.EmpiricalWalker
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.engine.MersenneTwister
Returns a copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.NegativeBinomial
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.Poisson
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.sampling.RandomSampler
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.sampling.RandomSamplingAssistant
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.sampling.WeightedRandomSampler
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.tdouble.AbstractDoubleDistribution
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.tdouble.BreitWignerMeanSquare
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.tdouble.Empirical
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.tdouble.EmpiricalWalker
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.tdouble.engine.DoubleMersenneTwister
Returns a copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.tdouble.NegativeBinomial
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.tdouble.Poisson
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.tdouble.sampling.DoubleRandomSampler
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.tdouble.sampling.DoubleRandomSamplingAssistant
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.tdouble.sampling.WeightedDoubleRandomSampler
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.tfloat.AbstractFloatDistribution
Returns a deep copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.tfloat.engine.FloatMersenneTwister
Returns a copy of the receiver; the copy will produce identical sequences.
clone() - Method in class cern.jet.random.tfloat.sampling.FloatRandomSampler
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.tfloat.sampling.FloatRandomSamplingAssistant
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.random.tfloat.sampling.WeightedFloatRandomSampler
Returns a deep copy of the receiver.
clone() - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Returns a deep copy of the receiver.
clone() - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Returns a deep copy of the receiver.
clone() - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Returns a deep copy of the receiver.
clone() - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Returns a deep copy of the receiver.
clone() - Method in class flanagan.analysis.ErrorProp
 
clone() - Method in class flanagan.math.Matrix
 
clone() - Method in class hep.aida.ref.Annotation
 
clone() - Method in class hep.aida.ref.function.AbstractIFunction
 
clone(String, IFunction) - Method in class hep.aida.ref.function.FunctionCatalog
 
clone() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns a deep copy of the receiver.
clone() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns a deep copy of the receiver.
clone() - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Returns a deep copy of the receiver.
clone() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns a deep copy of the receiver.
clone() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns a deep copy of the receiver.
clone() - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Returns a deep copy of the receiver.
clone() - Method in class hephysics.vec.SpacePoint
Clone
clone() - Method in class jhplot.math.Complex
 
clone() - Method in class jhplot.math.ValueErr
 
clone() - Method in class jhpro.stat.DataSource
Allow cloning
clone() - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns a clone of the dataset.
clone() - Method in class umontreal.iro.lecuyer.charts.EmpiricalRenderer
Returns a clone of the renderer.
clone() - Method in class umontreal.iro.lecuyer.functionfit.LeastSquares
 
clone() - Method in class umontreal.iro.lecuyer.functionfit.PolInterp
 
clone() - Method in class umontreal.iro.lecuyer.functions.Polynomial
 
clone() - Method in interface umontreal.iro.lecuyer.rng.CloneableRandomStream
Clones the current object and returns its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.F2NL607
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.GenF2w32
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.LFSR113
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.LFSR258
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.MRG31k3p
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.MRG32k3a
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.MRG32k3aL
 
clone() - Method in class umontreal.iro.lecuyer.rng.MT19937
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated. Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.RandRijndael
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.WELL1024
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.WELL512
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.rng.WELL607
Clones the current generator and return its copy.
clone() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Clone this object.
clone() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Clones this object.
clone() - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
Clones this object.
clone() - Method in class umontreal.iro.lecuyer.stat.list.ListOfTalliesWithCovariance
Clones this object.
clone() - Method in class umontreal.iro.lecuyer.stat.StatProbe
 
clone() - Method in class umontreal.iro.lecuyer.stat.Tally
Clones this object.
clone() - Method in class umontreal.iro.lecuyer.stat.TallyStore
Clones this object and the array which stores the observations.
clone() - Method in class umontreal.iro.lecuyer.util.BitMatrix
Creates a copy of the BitMatrix.
clone() - Method in class umontreal.iro.lecuyer.util.BitVector
Creates a copy of the BitVector.
clone() - Method in class umontreal.iro.lecuyer.util.ClassFinder
Clones this class finder, and copies its lists of import declarations.
CloneableRandomStream - Interface in umontreal.iro.lecuyer.rng
CloneableRandomStream extends RandomStream and Cloneable.
cloneFunction(String, IFunction) - Method in class hep.aida.ref.function.FunctionFactory
 
close() - Method in class hep.aida.ref.tree.Tree
Closes the underlying store.
close() - Method in class hep.aida.ref.tuple.FTupleAdapter
 
close() - Method in class hep.aida.ref.tuple.TupleCursor
 
close() - Method in class jhplot.HChart
Close the canvas (and dispose all components) Note: a memory leak is found - no time to investigate it.
close() - Method in class jhplot.HGraph
Close the canvas (and dispose all components) Note: a memory leak is found - no time to investgate it.
close() - Method in class jhplot.HPlot
Close the canvas (and dispose all components).
close() - Method in class jhplot.HPlot2D
Close the canvas (and dispose all components).
close() - Method in class jhplot.HPlot3D
Close the canvas (and dispose all components) Note: a memory leak is found - no time to study it.
close() - Method in class jhplot.HPlot3DP
Close the canvas (and dispose all components) Note: a memory leak is found - no time to study it.
close() - Method in class jhplot.HPlotJa
Close the canvas (and dispose all components).
close() - Method in class jhplot.HView3D
Close the canvas (and dispose all components) Note: a memory leak is found - no time to study it.
close() - Method in class jhplot.HZirkel
close current page
close() - Method in class jhplot.io.BaseRecordsFile
Closes the file.
close() - Method in class jhplot.io.csv.CSVReader
Closes the underlying reader.
close() - Method in class jhplot.io.csv.CSVWriter
Close the underlying stream writer flushing any buffered content.
close() - Method in class jhplot.io.EFile
Close the file
close() - Method in class jhplot.io.FileAida
Close the file
close() - Method in class jhplot.io.HDataBase
Close the file
close() - Method in class jhplot.io.HFile
Close the file
close() - Method in class jhplot.io.HFileXML
Close the file
close() - Method in class jhplot.io.PFile
Close the file
close() - Method in class jhplot.io.RecordsFile
Closes the database.
close() - Method in class jhplot.math.io.LEDataInputStream
 
close() - Method in class jhplot.math.io.LEDataOutputStream
 
close() - Method in class jhplot.math.io.LERandomAccessFile
 
closeButton - Variable in class jhplot.io.HFileBrowser
 
closeButton - Variable in class jhplot.io.PFileBrowser
 
closeReplayFile() - Method in class org.apache.commons.math.random.ValueServer
Closes valuesFileURL after use in REPLAY_MODE.
Cloud - Class in hep.aida.ref.histogram
 
Cloud1D - Class in hep.aida.ref.histogram
 
Cloud1D() - Constructor for class hep.aida.ref.histogram.Cloud1D
Create a new Cloud1D
Cloud2D - Class in hep.aida.ref.histogram
 
Cloud2D() - Constructor for class hep.aida.ref.histogram.Cloud2D
Create a new Cloud2D
Cloud3D - Class in hep.aida.ref.histogram
 
Cloud3D() - Constructor for class hep.aida.ref.histogram.Cloud3D
Create a new Cloud3D
CLOUD_ARRAY_ENTRIES - Static variable in class hep.aida.ref.histogram.Cloud
 
Cluster<T extends Clusterable<T>> - Class in org.apache.commons.math.stat.clustering
Cluster holding a set of Clusterable points.
Cluster(T) - Constructor for class org.apache.commons.math.stat.clustering.Cluster
Build a cluster centered at a specified point.
cluster(Collection<T>, int, int) - Method in class org.apache.commons.math.stat.clustering.KMeansPlusPlusClusterer
Runs the K-means++ clustering algorithm.
Clusterable<T> - Interface in org.apache.commons.math.stat.clustering
Interface for points that can be clustered together.
cm - Static variable in class cern.clhep.Units
 
CM - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Cramér-von Mises test
cm2 - Static variable in class cern.clhep.Units
 
cm3 - Static variable in class cern.clhep.Units
 
cmul(Vector3d) - Method in class jhplot.v3d.Vector3d
 
codeletString() - Method in class hep.aida.ref.fitter.InternalFitFunction
 
codeletString() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
codeletString() - Method in class hep.aida.ref.function.AbstractIFunction
 
codeletString() - Method in class hep.aida.ref.function.BaseModelFunction
 
codeletString() - Method in class hep.aida.ref.function.SumOfFunctions
 
coefficientOfVariation() - Method in class flanagan.analysis.Stat
 
coefficientOfVariation(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
coefficientOfVariation(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
coefficientOfVariation(double[]) - Static method in class flanagan.analysis.Stat
 
coefficientOfVariation(float[]) - Static method in class flanagan.analysis.Stat
 
coefficientOfVariation(BigInteger[], BigInteger[]) - Static method in class flanagan.analysis.Stat
 
coefficientOfVariation(BigDecimal[], BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
coefficientOfVariation(double[], double[]) - Static method in class flanagan.analysis.Stat
 
coefficientOfVariation(float[], float[]) - Static method in class flanagan.analysis.Stat
 
column(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
column(String) - Method in class hep.aida.ref.tuple.AbstractTuple
 
column(int) - Method in class hep.aida.ref.tuple.FTupleAdapter
 
column(int) - Method in class hep.aida.ref.tuple.Tuple
 
column(String) - Method in class hep.aida.ref.tuple.Tuple
 
columnByIndex(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnByIndex(int) - Method in interface hep.aida.ref.tuple.FTuple
 
columnByIndex(int) - Method in class hep.aida.ref.tuple.FTupleAdapter
 
columnByName(String) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnByName(String) - Method in interface hep.aida.ref.tuple.FTuple
 
columnByName(String) - Method in class hep.aida.ref.tuple.FTupleAdapter
 
columnDefaultString(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnDefaultString(int) - Method in class hep.aida.ref.tuple.ChainedTuple
 
columnDefaultString(int) - Method in class hep.aida.ref.tuple.Tuple
 
columnDefaultValue(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnDefaultValue(int) - Method in class hep.aida.ref.tuple.ChainedTuple
 
columnMatrix(double[]) - Static method in class flanagan.math.Matrix
 
columnMax(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnMax(int) - Method in class hep.aida.ref.tuple.ChainedTuple
Get the maximum value of a column.
columnMax(int) - Method in class hep.aida.ref.tuple.Tuple
 
columnMaxima() - Method in class flanagan.math.Matrix
 
columnMean(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnMean(int) - Method in class hep.aida.ref.tuple.ChainedTuple
Get the mean value of a column.
columnMean(int) - Method in class hep.aida.ref.tuple.Tuple
 
columnMeans() - Method in class flanagan.math.Matrix
 
columnMedians() - Method in class flanagan.math.Matrix
 
columnMin(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnMin(int) - Method in class hep.aida.ref.tuple.ChainedTuple
Get the minimum value of a column.
columnMin(int) - Method in class hep.aida.ref.tuple.Tuple
 
columnMinima() - Method in class flanagan.math.Matrix
 
columnName(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnName(int) - Method in class hep.aida.ref.tuple.ChainedTuple
Get the name of a column from its index
columnName(int) - Method in interface hep.aida.ref.tuple.FTuple
 
columnName(int) - Method in class hep.aida.ref.tuple.FTupleAdapter
 
columnName(int) - Method in class hep.aida.ref.tuple.Tuple
 
columnNames() - Method in class hep.aida.ref.tuple.AbstractTuple
 
ColumnPositionMappingStrategy - Class in jhplot.io.csv.bean
Copyright 2007 Kyle Miller.
ColumnPositionMappingStrategy() - Constructor for class jhplot.io.csv.bean.ColumnPositionMappingStrategy
 
columnRanges() - Method in class flanagan.math.Matrix
 
columnRms(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnRms(int) - Method in class hep.aida.ref.tuple.ChainedTuple
Get the rms of a column.
columnRms(int) - Method in class hep.aida.ref.tuple.Tuple
 
columns() - Method in class cern.colt.bitvector.BitMatrix
Returns the number of columns of the receiver.
columns() - Method in class cern.colt.matrix.AbstractMatrix2D
Returns the number of columns.
columns() - Method in class cern.colt.matrix.AbstractMatrix3D
Returns the number of columns.
columns() - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Returns the number of columns.
columns() - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Returns the number of columns.
columns() - Method in class cern.colt.matrix.tbit.BitMatrix
Returns the number of columns of the receiver.
COLUMNS - Static variable in class cern.jet.random.engine.RandomSeedTable
The number of columns of the matrix (currently COLUMNS = 2).
COLUMNS - Static variable in class cern.jet.random.tdouble.engine.RandomSeedTable
The number of columns of the matrix (currently COLUMNS = 2).
columns() - Method in class hep.aida.ref.tuple.AbstractTuple
 
columns() - Method in class hep.aida.ref.tuple.ChainedTuple
Get the number of columns in the Tuple.
columns() - Method in interface hep.aida.ref.tuple.FTuple
 
columns() - Method in class hep.aida.ref.tuple.FTupleAdapter
 
columns() - Method in class hep.aida.ref.tuple.Tuple
 
columnStandardDeviations() - Method in class flanagan.math.Matrix
 
columnStandardErrors() - Method in class flanagan.math.Matrix
 
columnStride() - Method in class cern.colt.matrix.AbstractMatrix2D
Returns the column stride.
columnStride() - Method in class cern.colt.matrix.AbstractMatrix3D
Returns the column stride.
columnSums() - Method in class flanagan.math.Matrix
 
columnType(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnType(int) - Method in class hep.aida.ref.tuple.ChainedTuple
Get the type of the column from its index
columnType(int) - Method in interface hep.aida.ref.tuple.FTuple
 
columnType(int) - Method in class hep.aida.ref.tuple.FTupleAdapter
 
columnType(int) - Method in class hep.aida.ref.tuple.Tuple
 
columnTypes() - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnValue(int, Value) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnValue(int, FTupleCursor, Value) - Method in class hep.aida.ref.tuple.AbstractTuple
 
columnValue(int, Value) - Method in class hep.aida.ref.tuple.ChainedTuple
 
columnValue(int, FTupleCursor, Value) - Method in interface hep.aida.ref.tuple.FTuple
 
columnValue(int, FTupleCursor, Value) - Method in class hep.aida.ref.tuple.FTupleAdapter
 
columnValue(int, FTupleCursor, Value) - Method in class hep.aida.ref.tuple.Tuple
 
columnValue(int, Value) - Method in class hep.aida.ref.tuple.Tuple
 
columnVariances() - Method in class flanagan.math.Matrix
 
columnVector(double[]) - Static method in class jhplot.math.DoubleArray
Converts an n element array into an n x 1 matrix.
combination(int, int) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the number of different combinations of s objects amongst n.
combine(UnivariateRealFunction, BivariateRealFunction) - Method in class org.apache.commons.math.analysis.ComposableFunction
Return a function combining the instance and another function.
CombinedEventsManager - Class in org.apache.commons.math.ode.events
Deprecated. as of 2.2, this class is not used anymore
CombinedEventsManager() - Constructor for class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Simple constructor.
combineErr(int) - Method in class jhplot.P1D
Add 1st and 2nd level in quadrature and attribute the combined error to 1st level error.
commit() - Method in class hep.aida.ref.tree.Tree
Commit any open transaction to the underlying store(s).
commonwealthDay() - Method in class flanagan.math.TimeAndDate
 
commonwealthDay(int) - Method in class flanagan.math.TimeAndDate
 
communalities() - Method in class flanagan.analysis.PCA
 
communalityWeights() - Method in class flanagan.analysis.PCA
 
compactness(double[][], int[], int, double[][]) - Static method in class jminhep.cluster.Get
This method returns the cluster compactness
comparatorPermutation(List<S>, Comparator<S>) - Static method in class org.apache.commons.math.genetics.RandomKey
Generates a representation of a permutation corresponding to the data sorted by comparator.
compare(byte, byte) - Method in interface cern.colt.function.ByteComparator
Compares its two arguments for order.
compare(char, char) - Method in interface cern.colt.function.CharComparator
Compares its two arguments for order.
compare(double, double) - Method in interface cern.colt.function.DoubleComparator
Compares its two arguments for order.
compare(float, float) - Method in interface cern.colt.function.FloatComparator
Compares its two arguments for order.
compare(int, int) - Method in interface cern.colt.function.IntComparator
Compares its two arguments for order.
compare(long, long) - Method in interface cern.colt.function.LongComparator
Compares its two arguments for order.
compare(short, short) - Method in interface cern.colt.function.ShortComparator
Compares its two arguments for order.
compare(byte, byte) - Method in interface cern.colt.function.tbyte.ByteComparator
Compares its two arguments for order.
compare(char, char) - Method in interface cern.colt.function.tchar.CharComparator
Compares its two arguments for order.
compare(double, double) - Method in interface cern.colt.function.tdouble.DoubleComparator
Compares its two arguments for order.
compare(float, float) - Method in interface cern.colt.function.tfloat.FloatComparator
Compares its two arguments for order.
compare(int, int) - Method in interface cern.colt.function.tint.IntComparator
Compares its two arguments for order.
compare(long, long) - Method in interface cern.colt.function.tlong.LongComparator
Compares its two arguments for order.
compare(short, short) - Method in interface cern.colt.function.tshort.ShortComparator
Compares its two arguments for order.
compare(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.doublealgo.DoubleMatrix1DComparator
Compares its two arguments for order.
compare(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.doublealgo.DoubleMatrix2DComparator
Compares its two arguments for order.
compare(ObjectMatrix1D, ObjectMatrix1D) - Method in interface cern.colt.matrix.objectalgo.ObjectMatrix1DComparator
Compares its two arguments for order.
compare(ObjectMatrix2D, ObjectMatrix2D) - Method in interface cern.colt.matrix.objectalgo.ObjectMatrix2DComparator
Compares its two arguments for order.
compare(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleMatrix1DComparator
Compares its two arguments for order.
compare(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleMatrix2DComparator
Compares its two arguments for order.
compare(FloatMatrix1D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatMatrix1DComparator
Compares its two arguments for order.
compare(FloatMatrix2D, FloatMatrix2D) - Method in interface cern.colt.matrix.tfloat.algo.FloatMatrix2DComparator
Compares its two arguments for order.
compare(IntMatrix1D, IntMatrix1D) - Method in interface cern.colt.matrix.tint.algo.IntMatrix1DComparator
Compares its two arguments for order.
compare(IntMatrix2D, IntMatrix2D) - Method in interface cern.colt.matrix.tint.algo.IntMatrix2DComparator
Compares its two arguments for order.
compare(LongMatrix1D, LongMatrix1D) - Method in interface cern.colt.matrix.tlong.algo.LongMatrix1DComparator
Compares its two arguments for order.
compare(LongMatrix2D, LongMatrix2D) - Method in interface cern.colt.matrix.tlong.algo.LongMatrix2DComparator
Compares its two arguments for order.
compare(ObjectMatrix1D, ObjectMatrix1D) - Method in interface cern.colt.matrix.tobject.algo.ObjectMatrix1DComparator
Compares its two arguments for order.
compare(ObjectMatrix2D, ObjectMatrix2D) - Method in interface cern.colt.matrix.tobject.algo.ObjectMatrix2DComparator
Compares its two arguments for order.
compare - Static variable in class cern.jet.math.Functions
Function that returns a < b ? -1 : a > b ? 1 : 0.
compare(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a < b ? -1 : a > b ? 1 : 0.
compare - Static variable in class cern.jet.math.IntFunctions
Function that returns a < b ? -1 : a > b ? 1 : 0.
compare(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a < b ? -1 : a > b ? 1 : 0.
compare - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a < b ? -1 : a > b ? 1 : 0.
compare(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a < b ? -1 : a > b ? 1 : 0.
compare - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a < b ? -1 : a > b ? 1 : 0.
compare(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a < b ? -1 : a > b ? 1 : 0.
compare - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a < b ? -1 : a > b ? 1 : 0.
compare(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a < b ? -1 : a > b ? 1 : 0.
compare - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a < b ? -1 : a > b ? 1 : 0.
compare(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a < b ? -1 : a > b ? 1 : 0.
compare(double, double) - Static method in class flanagan.math.Fmath
 
compare(int, int) - Static method in class flanagan.math.Fmath
 
compare(long, long) - Static method in class flanagan.math.Fmath
 
compare(float, float) - Static method in class flanagan.math.Fmath
 
compare(byte, byte) - Static method in class flanagan.math.Fmath
 
compare(short, short) - Static method in class flanagan.math.Fmath
 
compare(double[], double[]) - Method in class umontreal.iro.lecuyer.util.DoubleArrayComparator
Returns -1, 0, or 1 depending on whether d1[i] is less than, equal to, or greater than d2[i].
compareTo(BigFraction) - Method in class org.apache.commons.math.fraction.BigFraction
Compares this object to another based on size.
compareTo(Fraction) - Method in class org.apache.commons.math.fraction.Fraction
Compares this object to another based on size.
compareTo(Chromosome) - Method in class org.apache.commons.math.genetics.Chromosome
Compares two chromosomes based on their fitness.
compareTo(BigReal) - Method in class org.apache.commons.math.util.BigReal
compareTo(double, double, double) - Static method in class org.apache.commons.math.util.MathUtils
Compares two numbers given some amount of allowed error.
compareTo(Event) - Method in class umontreal.iro.lecuyer.simevents.Event
Compares this object with the specified object e for order.
compareWith(AbstractBin1D) - Method in class cern.hep.aida.bin.AbstractBin1D
Computes the deviations from the receiver's measures to another bin's measures.
compareWith(AbstractBin1D) - Method in class cern.hep.aida.bin.MightyStaticBin1D
Computes the deviations from the receiver's measures to another bin's measures.
compareWith(AbstractBin1D) - Method in class cern.hep.aida.bin.QuantileBin1D
Computes the deviations from the receiver's measures to another bin's measures.
compareWith(AbstractDoubleBin1D) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Computes the deviations from the receiver's measures to another bin's measures.
compareWith(AbstractDoubleBin1D) - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Computes the deviations from the receiver's measures to another bin's measures.
compareWith(AbstractDoubleBin1D) - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Computes the deviations from the receiver's measures to another bin's measures.
compareWith(AbstractFloatBin1D) - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Computes the deviations from the receiver's measures to another bin's measures.
compareWith(AbstractFloatBin1D) - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Computes the deviations from the receiver's measures to another bin's measures.
compareWith(AbstractFloatBin1D) - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Computes the deviations from the receiver's measures to another bin's measures.
complementaryRegularisedGammaFunction(double, double) - Static method in class flanagan.analysis.Stat
 
complementaryRegularizedGammaFunction(double, double) - Static method in class flanagan.analysis.Stat
 
Complex - Class in jhplot.math
Complex implements a complex number and defines complex arithmetic and mathematical functions Last Updated February 27, 2001 Copyright 1997-2001
Complex(double, double) - Constructor for class jhplot.math.Complex
Constructs the complex number z = u + i*v
Complex - Class in org.apache.commons.math.complex
Representation of a Complex number - a number which has both a real and imaginary part.
Complex(double, double) - Constructor for class org.apache.commons.math.complex.Complex
Create a complex number given the real and imaginary parts.
ComplexField - Class in org.apache.commons.math.complex
Representation of the complex numbers field.
ComplexFormat - Class in org.apache.commons.math.complex
Formats a Complex number in cartesian format "Re(c) + Im(c)i".
ComplexFormat() - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with the default imaginary character, 'i', and the default number format for both real and imaginary parts.
ComplexFormat(NumberFormat) - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with a custom number format for both real and imaginary parts.
ComplexFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with a custom number format for the real part and a custom number format for the imaginary part.
ComplexFormat(String) - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with a custom imaginary character, and the default number format for both real and imaginary parts.
ComplexFormat(String, NumberFormat) - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with a custom imaginary character, and a custom number format for both real and imaginary parts.
ComplexFormat(String, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math.complex.ComplexFormat
Create an instance with a custom imaginary character, a custom number format for the real part, and a custom number format for the imaginary part.
ComplexUtils - Class in org.apache.commons.math.complex
Static implementations of common Complex utilities functions.
componentHidden(ComponentEvent) - Method in class jhplot.GHFrame
 
componentHidden(ComponentEvent) - Method in class jhplot.GHPanel
 
componentMoved(ComponentEvent) - Method in class jhplot.GHFrame
 
componentMoved(ComponentEvent) - Method in class jhplot.GHPanel
 
componentResized(ComponentEvent) - Method in class jhplot.GHPanel
 
componentShown(ComponentEvent) - Method in class jhplot.GHFrame
 
componentShown(ComponentEvent) - Method in class jhplot.GHPanel
 
ComposableFunction - Class in org.apache.commons.math.analysis
Base class for UnivariateRealFunction that can be composed with other functions.
ComposableFunction() - Constructor for class org.apache.commons.math.analysis.ComposableFunction
 
compose(DoubleMatrix2D[][]) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a block matrix made from the given parts.
compose(ObjectMatrix2D[][]) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a block matrix made from the given parts.
compose(DComplexMatrix2D[][]) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a block matrix made from the given parts.
compose(DoubleMatrix2D[][]) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a block matrix made from the given parts.
compose(FComplexMatrix2D[][]) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a block matrix made from the given parts.
compose(FloatMatrix2D[][]) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a block matrix made from the given parts.
compose(IntMatrix2D[][]) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a block matrix made from the given parts.
compose(LongMatrix2D[][]) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a block matrix made from the given parts.
compose(ObjectMatrix2D[][]) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
Constructs a block matrix made from the given parts.
composeBidiagonal(DComplexMatrix2D, DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a bidiagonal block matrix from the given parts.
composeBidiagonal(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a bidiagonal block matrix from the given parts.
composeBidiagonal(FComplexMatrix2D, FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a bidiagonal block matrix from the given parts.
composeBidiagonal(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a bidiagonal block matrix from the given parts.
composeBidiagonal(IntMatrix2D, IntMatrix2D) - Method in class cern.colt.matrix.tint.IntFactory2D
 
composeBidiagonal(LongMatrix2D, LongMatrix2D) - Method in class cern.colt.matrix.tlong.LongFactory2D
 
composeDiagonal(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(DoubleMatrix2D, DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a diagonal block matrix from the given parts.
composeDiagonal(ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(ObjectMatrix2D, ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a diagonal block matrix from the given parts.
composeDiagonal(DComplexMatrix2D, DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(DComplexMatrix2D, DComplexMatrix2D, DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a diagonal block matrix from the given parts.
composeDiagonal(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(DoubleMatrix2D, DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a diagonal block matrix from the given parts.
composeDiagonal(FComplexMatrix2D, FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(FComplexMatrix2D, FComplexMatrix2D, FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a diagonal block matrix from the given parts.
composeDiagonal(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(FloatMatrix2D, FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a diagonal block matrix from the given parts.
composeDiagonal(IntMatrix2D, IntMatrix2D) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(IntMatrix2D, IntMatrix2D, IntMatrix2D) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a diagonal block matrix from the given parts.
composeDiagonal(LongMatrix2D, LongMatrix2D) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(LongMatrix2D, LongMatrix2D, LongMatrix2D) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a diagonal block matrix from the given parts.
composeDiagonal(ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
Constructs a diagonal block matrix from the given parts (the direct sum of two matrices).
composeDiagonal(ObjectMatrix2D, ObjectMatrix2D, ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
Constructs a diagonal block matrix from the given parts.
CompositeFormat - Class in org.apache.commons.math.util
Base class for formatters of composite objects (complex numbers, vectors ...).
CompositeFormat() - Constructor for class org.apache.commons.math.util.CompositeFormat
 
computeCorrelationMatrix(RealMatrix) - Method in class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Computes the correlation matrix for the columns of the input matrix.
computeCorrelationMatrix(double[][]) - Method in class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Computes the correlation matrix for the columns of the input rectangular array.
computeCorrelationMatrix(RealMatrix) - Method in class org.apache.commons.math.stat.correlation.SpearmansCorrelation
Computes the Spearman's rank correlation matrix for the columns of the input matrix.
computeCorrelationMatrix(double[][]) - Method in class org.apache.commons.math.stat.correlation.SpearmansCorrelation
Computes the Spearman's rank correlation matrix for the columns of the input rectangular array.
computeDensity(EmpiricalDist, ContinuousDistribution, double, double[]) - Static method in class umontreal.iro.lecuyer.gof.KernelDensity
Given the empirical distribution dist, this method computes the kernel density estimate at each of the m points Y[j], j = 0, 1,…,(m - 1), where m is the length of Y, the kernel is kern.density(x), and the bandwidth is h.
computeDensity(EmpiricalDist, ContinuousDistribution, double[]) - Static method in class umontreal.iro.lecuyer.gof.KernelDensity
Similar to method , but the bandwidth h is obtained from the method KernelDensityGen.getBaseBandwidth(dist) in package randvar.
computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math.ode.AbstractIntegrator
Compute the derivatives and check the number of evaluations.
computeDerivatives(double, double[], double[]) - Method in class org.apache.commons.math.ode.FirstOrderConverter
Get the current time derivative of the state vector.
computeDerivatives(double, double[], double[]) - Method in interface org.apache.commons.math.ode.FirstOrderDifferentialEquations
Get the current time derivative of the state vector.
computeDistribution() - Method in class org.apache.commons.math.random.ValueServer
Computes the empirical distribution using values from the file in valuesFileURL, using the default number of bins.
computeDistribution(int) - Method in class org.apache.commons.math.random.ValueServer
Computes the empirical distribution using values from the file in valuesFileURL and binCount bins.
computeExp(Dfp, Dfp) - Static method in class org.apache.commons.math.dfp.DfpField
Compute exp(a).
computeJacobians(double, double[], double[], double[][], double[][]) - Method in interface org.apache.commons.math.ode.jacobians.ODEWithJacobians
Deprecated. Compute the partial derivatives of ODE with respect to state.
computeLn(Dfp, Dfp, Dfp) - Static method in class org.apache.commons.math.dfp.DfpField
Compute ln(a).
computeMatrix() - Method in class jhplot.v3d.Model3d
 
computeSecondDerivatives(double, double[], double[], double[]) - Method in interface org.apache.commons.math.ode.SecondOrderDifferentialEquations
Get the current time derivative of the state vector.
concatenate(Stat) - Method in class flanagan.analysis.Stat
 
concatenate(ArrayMaths) - Method in class flanagan.analysis.Stat
 
concatenate(double[]) - Method in class flanagan.analysis.Stat
 
concatenate(float[]) - Method in class flanagan.analysis.Stat
 
concatenate(long[]) - Method in class flanagan.analysis.Stat
 
concatenate(int[]) - Method in class flanagan.analysis.Stat
 
concatenate(short[]) - Method in class flanagan.analysis.Stat
 
concatenate(byte[]) - Method in class flanagan.analysis.Stat
 
concatenate(char[]) - Method in class flanagan.analysis.Stat
 
concatenate(Double[]) - Method in class flanagan.analysis.Stat
 
concatenate(Float[]) - Method in class flanagan.analysis.Stat
 
concatenate(Long[]) - Method in class flanagan.analysis.Stat
 
concatenate(Integer[]) - Method in class flanagan.analysis.Stat
 
concatenate(Short[]) - Method in class flanagan.analysis.Stat
 
concatenate(Byte[]) - Method in class flanagan.analysis.Stat
 
concatenate(Character[]) - Method in class flanagan.analysis.Stat
 
concatenate(String[]) - Method in class flanagan.analysis.Stat
 
concatenate(BigDecimal[]) - Method in class flanagan.analysis.Stat
 
concatenate(BigInteger[]) - Method in class flanagan.analysis.Stat
 
concatenate(Complex[]) - Method in class flanagan.analysis.Stat
 
concatenate(Phasor[]) - Method in class flanagan.analysis.Stat
 
concatenate(double[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(Double[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(float[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(Float[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(long[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(Long[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(int[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(Integer[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(short[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(Short[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(byte[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(Byte[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(BigDecimal[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(BigInteger[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(Complex[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(Phasor[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(String[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(char[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(Character[]) - Method in class flanagan.math.ArrayMaths
 
concatenate(ArrayMaths) - Method in class flanagan.math.ArrayMaths
 
concatenate(Stat) - Method in class flanagan.math.ArrayMaths
 
concatenate(double[], double[]) - Static method in class flanagan.math.Fmath
 
concatenate(float[], float[]) - Static method in class flanagan.math.Fmath
 
concatenate(int[], int[]) - Static method in class flanagan.math.Fmath
 
concatenate(long[], long[]) - Static method in class flanagan.math.Fmath
 
concatenate(short[], short[]) - Static method in class flanagan.math.Fmath
 
concatenate(byte[], byte[]) - Static method in class flanagan.math.Fmath
 
concatenate(char[], char[]) - Static method in class flanagan.math.Fmath
 
concatenate(String[], String[]) - Static method in class flanagan.math.Fmath
 
concatenate(Object[], Object[]) - Static method in class flanagan.math.Fmath
 
concatenate(File, File) - Static method in class jhplot.math.io.ASCIIFile
 
cond(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the condition of matrix A, which is the ratio of largest to smallest singular value.
cond() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the two norm condition number, which is max(S) / min(S).
cond() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleSingularValueDecomposition
Returns the two norm condition number, which is max(S) / min(S).
cond(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the condition of matrix A, which is the ratio of largest to smallest singular value.
cond() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatSingularValueDecomposition
Returns the two norm condition number, which is max(S) / min(S).
cond(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the condition of matrix A, which is the ratio of largest to smallest singular value.
cond(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
cond() - Method in class jhplot.math.SingularValueDecomposition
Two norm condition number
Condition - Class in umontreal.iro.lecuyer.simprocs
A Condition is a boolean indicator, with a list of processes waiting for the indicator to be true (when it is false).
Condition(boolean) - Constructor for class umontreal.iro.lecuyer.simprocs.Condition
Constructs a new Condition with initial value val, linked with the default simulator.
Condition(ProcessSimulator, boolean) - Constructor for class umontreal.iro.lecuyer.simprocs.Condition
Constructs a new Condition with initial value val, linked with simulator sim.
Condition(boolean, String) - Constructor for class umontreal.iro.lecuyer.simprocs.Condition
Constructs a new Condition with initial value val, identifier name and linked with the default simulator.
Condition(ProcessSimulator, boolean, String) - Constructor for class umontreal.iro.lecuyer.simprocs.Condition
Constructs a new Condition with initial value val, identifier name and linked with simulator sim.
Cone - Class in jhplot.v3d
Build a cone.
Cone(Model3d, float, int, Vector3d) - Constructor for class jhplot.v3d.Cone
 
Cone(Model3d, float, int, float) - Constructor for class jhplot.v3d.Cone
 
confidenceIntervalNormal(double, double[]) - Method in class umontreal.iro.lecuyer.stat.Tally
Computes a confidence interval on the mean.
confidenceIntervalStudent(double, double[]) - Method in class umontreal.iro.lecuyer.stat.Tally
Computes a confidence interval on the mean.
confidenceIntervalVarianceChi2(double, double[]) - Method in class umontreal.iro.lecuyer.stat.Tally
Computes a confidence interval on the variance.
ConfidenceLevel - Class in jhpro.stat
Confidence level calculations.
ConfidenceLevel() - Constructor for class jhpro.stat.ConfidenceLevel
Default constructor.
ConfidenceLevel(int) - Constructor for class jhpro.stat.ConfidenceLevel
Construct ConfLevel
ConfidenceLevel(int, boolean) - Constructor for class jhpro.stat.ConfidenceLevel
Build confidence level.
ConfInterval - Class in jhpro.stat
Computes the mean, standard deviation and 95% approximate confidence interval.
ConfInterval(P0D) - Constructor for class jhpro.stat.ConfInterval
Initialize calculation of confidence interval.
conj(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
conj - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
conj(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
conj - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
conj() - Method in class jhplot.math.Complex
Complex conjugate of this Complex number (the conjugate of x+i*y is x-i*y).
conjugate() - Method in class org.apache.commons.math.complex.Complex
Return the conjugate of this complex number.
ConjugateGradientFormula - Enum in org.apache.commons.math.optimization.general
Available choices of update formulas for the β parameter in NonLinearConjugateGradientOptimizer.
Connectable - Interface in hep.aida.ref.event
 
ConnectEvent - Class in hep.aida.ref.event
An event send to AIDAListeners if connection between AIDA object and it's data provider is re-open
ConnectEvent(Object) - Constructor for class hep.aida.ref.event.ConnectEvent
 
ConnectEvent(Object, boolean) - Constructor for class hep.aida.ref.event.ConnectEvent
 
connectToDatabase(Properties) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Connects to the database using the properties prop and returns the an object representing the connection.
connectToDatabase(InputStream) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns a connection to the database using the properties read from stream is.
connectToDatabase(URL) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Equivalent to connectToDatabase (url.openStream()).
connectToDatabase(File) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Equivalent to connectToDatabase (new FileInputStream (file)).
connectToDatabase(String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Equivalent to connectToDatabase (new FileInputStream (fileName)).
connectToDatabaseFromResource(String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Uses connectToDatabase with the stream obtained from the resource resource.
constant(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns the constant c.
constant(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns the constant c.
constant(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
constant(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns the constant c.
constant(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
constant(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns the constant c.
constant(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns the constant c.
constant(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns the constant c.
constant() - Method in class flanagan.analysis.Regression
 
CONSTANT_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Always return mu
constantPlot(String, String) - Method in class flanagan.analysis.Regression
 
constantPlot() - Method in class flanagan.analysis.Regression
 
Constants - Class in cern.jet.math
Defines some useful constants.
Constants - Interface in jhplot.math.num
Common constants found in mathematical formulas.
constraints() - Method in class hep.aida.ref.fitter.FitResult
 
constraints() - Method in class hep.aida.ref.fitter.Fitter
 
ContainerManagedObject - Class in hep.aida.ref
 
ContainerManagedObject(String) - Constructor for class hep.aida.ref.ContainerManagedObject
 
ContainerPointSet - Class in umontreal.iro.lecuyer.hups
This acts as a generic base class for all container classes that contain a point set and apply some kind of transformation to the coordinates to define a new point set.
ContainerPointSet() - Constructor for class umontreal.iro.lecuyer.hups.ContainerPointSet
 
contains(boolean) - Method in class cern.colt.list.AbstractBooleanList
Returns true if the receiver contains the specified element.
contains(byte) - Method in class cern.colt.list.AbstractByteList
Returns true if the receiver contains the specified element.
contains(char) - Method in class cern.colt.list.AbstractCharList
Returns true if the receiver contains the specified element.
contains(double) - Method in class cern.colt.list.AbstractDoubleList
Returns true if the receiver contains the specified element.
contains(float) - Method in class cern.colt.list.AbstractFloatList
Returns true if the receiver contains the specified element.
contains(int) - Method in class cern.colt.list.AbstractIntList
Returns true if the receiver contains the specified element.
contains(long) - Method in class cern.colt.list.AbstractLongList
Returns true if the receiver contains the specified element.
contains(short) - Method in class cern.colt.list.AbstractShortList
Returns true if the receiver contains the specified element.
contains(Object, boolean) - Method in class cern.colt.list.ObjectArrayList
Returns true if the receiver contains the specified element.
contains(boolean) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns true if the receiver contains the specified element.
contains(byte) - Method in class cern.colt.list.tbyte.AbstractByteList
Returns true if the receiver contains the specified element.
contains(char) - Method in class cern.colt.list.tchar.AbstractCharList
Returns true if the receiver contains the specified element.
contains(double) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns true if the receiver contains the specified element.
contains(float) - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns true if the receiver contains the specified element.
contains(int) - Method in class cern.colt.list.tint.AbstractIntList
Returns true if the receiver contains the specified element.
contains(long) - Method in class cern.colt.list.tlong.AbstractLongList
Returns true if the receiver contains the specified element.
contains(Object, boolean) - Method in class cern.colt.list.tobject.ObjectArrayList
Returns true if the receiver contains the specified element.
contains(short) - Method in class cern.colt.list.tshort.AbstractShortList
Returns true if the receiver contains the specified element.
contains(double) - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Returns whether the specified element is contained in the receiver.
contains(double) - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Returns whether the specified element is contained in the receiver.
contains(double) - Method in class jhplot.P0D
Returns true if value exists
contains(Integer) - Method in class jhplot.P0I
Returns true if value exists
contains(double, double) - Method in class jhplot.shapes.HShape
 
contains(Object) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
containsAll(Collection<?>) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
containsClass(Class<?>) - Method in class org.apache.commons.math.util.TransformerMap
Tests if a Class is present in the TransformerMap.
containsFunction(IFunction) - Method in class hep.aida.ref.function.SumOfFunctions
 
containsKey(double) - Method in class cern.colt.map.AbstractDoubleIntMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.AbstractIntDoubleMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.AbstractIntIntMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.AbstractIntObjectMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.AbstractLongObjectMap
Returns true if the receiver contains the specified key.
containsKey(double) - Method in class cern.colt.map.OpenDoubleIntHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.OpenIntDoubleHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.OpenIntIntHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.OpenIntObjectHashMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.OpenLongObjectHashMap
Returns true if the receiver contains the specified key.
containsKey(double) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Returns true if the receiver contains the specified key.
containsKey(double) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Returns true if the receiver contains the specified key.
containsKey(double) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Returns true if the receiver contains the specified key.
containsKey(double) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Returns true if the receiver contains the specified key.
containsKey(float) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Returns true if the receiver contains the specified key.
containsKey(float) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Returns true if the receiver contains the specified key.
containsKey(float) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Returns true if the receiver contains the specified key.
containsKey(float) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.tint.AbstractIntIntMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Returns true if the receiver contains the specified key.
containsKey(long) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Returns true if the receiver contains the specified key.
containsKey(int) - Method in class org.apache.commons.math.util.OpenIntToDoubleHashMap
Check if a value is associated with a key.
containsKey(int) - Method in class org.apache.commons.math.util.OpenIntToFieldHashMap
Check if a value is associated with a key.
containsTransformer(NumberTransformer) - Method in class org.apache.commons.math.util.TransformerMap
Tests if a NumberTransformer is present in the TransformerMap.
containsValue(int) - Method in class cern.colt.map.AbstractDoubleIntMap
Returns true if the receiver contains the specified value.
containsValue(double) - Method in class cern.colt.map.AbstractIntDoubleMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.AbstractIntIntMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.AbstractIntObjectMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.AbstractLongObjectMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.OpenDoubleIntHashMap
Returns true if the receiver contains the specified value.
containsValue(double) - Method in class cern.colt.map.OpenIntDoubleHashMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.OpenIntIntHashMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.OpenIntObjectHashMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.OpenLongObjectHashMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Returns true if the receiver contains the specified value.
containsValue(long) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Returns true if the receiver contains the specified value.
containsValue(double) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Returns true if the receiver contains the specified value.
containsValue(double) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Returns true if the receiver contains the specified value.
containsValue(long) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Returns true if the receiver contains the specified value.
containsValue(double) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Returns true if the receiver contains the specified value.
containsValue(double) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Returns true if the receiver contains the specified value.
containsValue(long) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Returns true if the receiver contains the specified value.
containsValue(float) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Returns true if the receiver contains the specified value.
containsValue(float) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Returns true if the receiver contains the specified value.
containsValue(long) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Returns true if the receiver contains the specified value.
containsValue(float) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Returns true if the receiver contains the specified value.
containsValue(float) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.tint.AbstractIntIntMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Returns true if the receiver contains the specified value.
containsValue(long) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Returns true if the receiver contains the specified value.
containsValue(long) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Returns true if the receiver contains the specified value.
containsValue(long) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Returns true if the receiver contains the specified value.
containsValue(int) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Returns true if the receiver contains the specified value.
containsValue(long) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Returns true if the receiver contains the specified value.
containsValue(Object) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Returns true if the receiver contains the specified value.
contFract(double, double, double) - Static method in class flanagan.analysis.Stat
 
CONTINUE - Static variable in interface org.apache.commons.math.ode.events.EventHandler
Continue indicator.
CONTINUE - Static variable in interface org.apache.commons.math.ode.jacobians.EventHandlerWithJacobians
Deprecated. Continue indicator.
ContinuedFraction - Class in jhplot.math.num
This class provides the means to evaluate continued fractions (1).
ContinuedFraction - Class in org.apache.commons.math.util
Provides a generic means to evaluate continued fractions.
Continuous - Class in umontreal.iro.lecuyer.simevents
Represents a variable in a continuous-time simulation.
Continuous() - Constructor for class umontreal.iro.lecuyer.simevents.Continuous
Constructs a new continuous-time variable linked to the default simulator, without initializing it.
Continuous(Simulator) - Constructor for class umontreal.iro.lecuyer.simevents.Continuous
Constructs a new continuous-time variable linked to the given simulator, without initializing it.
ContinuousDistChart - Class in umontreal.iro.lecuyer.charts
This class provides tools to plot the density and the cumulative probability of a continuous probability distribution.
ContinuousDistChart(ContinuousDistribution, double, double, int) - Constructor for class umontreal.iro.lecuyer.charts.ContinuousDistChart
Constructor for a new ContinuousDistChart instance.
ContinuousDistribution - Class in jhplot.math.num.pdf
Base continuous distribution.
ContinuousDistribution() - Constructor for class jhplot.math.num.pdf.ContinuousDistribution
 
ContinuousDistribution - Interface in org.apache.commons.math.distribution
Base interface for continuous distributions.
ContinuousDistribution - Class in umontreal.iro.lecuyer.probdist
Classes implementing continuous distributions should inherit from this base class.
ContinuousDistribution() - Constructor for class umontreal.iro.lecuyer.probdist.ContinuousDistribution
 
ContinuousDistribution2Dim - Class in umontreal.iro.lecuyer.probdistmulti
Classes implementing 2-dimensional continuous distributions should inherit from this class.
ContinuousDistribution2Dim() - Constructor for class umontreal.iro.lecuyer.probdistmulti.ContinuousDistribution2Dim
 
ContinuousDistributionMulti - Class in umontreal.iro.lecuyer.probdistmulti
Classes implementing continuous multi-dimensional distributions should inherit from this class.
ContinuousDistributionMulti() - Constructor for class umontreal.iro.lecuyer.probdistmulti.ContinuousDistributionMulti
 
ContinuousOutputModel - Class in org.apache.commons.math.ode
This class stores all information provided by an ODE integrator during the integration process and build a continuous model of the solution from this.
ContinuousOutputModel() - Constructor for class org.apache.commons.math.ode.ContinuousOutputModel
Simple constructor.
ContinuousRandomVariable - Interface in jhplot.math.num.random
A random variable generator for a continuous distribution.
ContinuousState - Class in umontreal.iro.lecuyer.simevents
Represents the portion of the simulator's state associated with continuous-time simulation.
continuousState() - Method in class umontreal.iro.lecuyer.simevents.Simulator
Returns the current state of continuous variables being integrated during the simulation.
ContinuousState.IntegMethod - Enum in umontreal.iro.lecuyer.simevents
 
contract() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Contracts the storage array to the (size of the element set) + 1 - to avoid a zero length array.
Conv - Class in flanagan.math
 
Conv() - Constructor for class flanagan.math.Conv
 
converged(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
converged(double, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
converged(double) - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
converged(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
converged(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Checks for convergence
converged(double, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Checks for convergence
converged(double) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Checks for convergence
converged(DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Checks for convergence
converged(double, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
 
converged(double) - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
 
converged(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
converged(float, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
converged(float) - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
converged(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
converged(FloatMatrix1D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Checks for convergence
converged(float, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Checks for convergence
converged(float) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Checks for convergence
converged(FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Checks for convergence
converged(float, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
 
converged(float) - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
 
converged(int, RealPointValuePair, RealPointValuePair) - Method in interface org.apache.commons.math.optimization.RealConvergenceChecker
Check if the optimization algorithm has converged considering the last points.
converged(int, RealPointValuePair, RealPointValuePair) - Method in class org.apache.commons.math.optimization.SimpleRealPointChecker
Check if the optimization algorithm has converged considering the last points.
converged(int, RealPointValuePair, RealPointValuePair) - Method in class org.apache.commons.math.optimization.SimpleScalarValueChecker
Check if the optimization algorithm has converged considering the last points.
converged(int, VectorialPointValuePair, VectorialPointValuePair) - Method in class org.apache.commons.math.optimization.SimpleVectorialPointChecker
Check if the optimization algorithm has converged considering the last points.
converged(int, VectorialPointValuePair, VectorialPointValuePair) - Method in class org.apache.commons.math.optimization.SimpleVectorialValueChecker
Check if the optimization algorithm has converged considering the last points.
converged(int, VectorialPointValuePair, VectorialPointValuePair) - Method in interface org.apache.commons.math.optimization.VectorialConvergenceChecker
Check if the optimization algorithm has converged considering the last points.
ConvergenceException - Exception in jhplot.math.num
The exception raised when an iterative method fails to converge.
ConvergenceException(String) - Constructor for exception jhplot.math.num.ConvergenceException
Create an execption with the given message.
ConvergenceException - Exception in org.apache.commons.math
Error thrown when a numerical computation can not be performed because the numerical result failed to converge to a finite value.
ConvergenceException() - Constructor for exception org.apache.commons.math.ConvergenceException
Default constructor.
ConvergenceException(String, Object...) - Constructor for exception org.apache.commons.math.ConvergenceException
Deprecated. as of 2.2 replaced by ConvergenceException.ConvergenceException(Localizable, Object...)
ConvergenceException(Localizable, Object...) - Constructor for exception org.apache.commons.math.ConvergenceException
Constructs an exception with specified formatted detail message.
ConvergenceException(Throwable) - Constructor for exception org.apache.commons.math.ConvergenceException
Create an exception with a given root cause.
ConvergenceException(Throwable, String, Object...) - Constructor for exception org.apache.commons.math.ConvergenceException
Deprecated. as of 2.2 replaced by ConvergenceException.ConvergenceException(Throwable, Localizable, Object...)
ConvergenceException(Throwable, Localizable, Object...) - Constructor for exception org.apache.commons.math.ConvergenceException
Constructs an exception with specified formatted detail message and root cause.
ConvergenceException - Exception in org.apache.commons.math.exception
Error thrown when a numerical computation can not be performed because the numerical result failed to converge to a finite value.
ConvergenceException() - Constructor for exception org.apache.commons.math.exception.ConvergenceException
Construct the exception.
ConvergenceException(Localizable) - Constructor for exception org.apache.commons.math.exception.ConvergenceException
Construct the exception with a specific context.
ConvergenceException(Localizable, Object...) - Constructor for exception org.apache.commons.math.exception.ConvergenceException
Construct the exception with a specific context and arguments.
ConvergingAlgorithm - Interface in org.apache.commons.math
Deprecated. in 2.2 (to be removed in 3.0). The concept of "iteration" will be moved to a new IterativeAlgorithm. The concept of "accuracy" is currently is also contained in SimpleRealPointChecker and similar classes.
ConvergingAlgorithmImpl - Class in org.apache.commons.math
Deprecated. in 2.2 (to be removed in 3.0).
conversionBins() - Method in class hep.aida.ref.histogram.Cloud1D
 
conversionBinsX() - Method in class hep.aida.ref.histogram.Cloud2D
 
conversionBinsX() - Method in class hep.aida.ref.histogram.Cloud3D
 
conversionBinsY() - Method in class hep.aida.ref.histogram.Cloud2D
 
conversionBinsY() - Method in class hep.aida.ref.histogram.Cloud3D
 
conversionBinsZ() - Method in class hep.aida.ref.histogram.Cloud3D
 
conversionLowerEdge() - Method in class hep.aida.ref.histogram.Cloud1D
 
conversionLowerEdgeX() - Method in class hep.aida.ref.histogram.Cloud2D
 
conversionLowerEdgeX() - Method in class hep.aida.ref.histogram.Cloud3D
 
conversionLowerEdgeY() - Method in class hep.aida.ref.histogram.Cloud2D
 
conversionLowerEdgeY() - Method in class hep.aida.ref.histogram.Cloud3D
 
conversionLowerEdgeZ() - Method in class hep.aida.ref.histogram.Cloud3D
 
conversionUpperEdge() - Method in class hep.aida.ref.histogram.Cloud1D
 
conversionUpperEdgeX() - Method in class hep.aida.ref.histogram.Cloud2D
 
conversionUpperEdgeX() - Method in class hep.aida.ref.histogram.Cloud3D
 
conversionUpperEdgeY() - Method in class hep.aida.ref.histogram.Cloud2D
 
conversionUpperEdgeY() - Method in class hep.aida.ref.histogram.Cloud3D
 
conversionUpperEdgeZ() - Method in class hep.aida.ref.histogram.Cloud3D
 
convert(int, double, double) - Method in class hep.aida.ref.histogram.Cloud1D
Convert the ICloud to an IHistogram.
convert(double[]) - Method in class hep.aida.ref.histogram.Cloud1D
Convert the ICloud to an IHistogram by specifying the bin edges.
convert(int, double, double, int, double, double) - Method in class hep.aida.ref.histogram.Cloud2D
Convert the Cloud to a Histogram.
convert(double[], double[]) - Method in class hep.aida.ref.histogram.Cloud2D
Convert the ICloud to an IHistogram by specifying the bin edges.
convert(int, double, double, int, double, double, int, double, double) - Method in class hep.aida.ref.histogram.Cloud3D
Convert the Cloud to a Histogram.
convert(double[], double[], double[]) - Method in class hep.aida.ref.histogram.Cloud3D
 
convert(double, TimeUnit, TimeUnit) - Static method in enum umontreal.iro.lecuyer.util.TimeUnit
Converts value expressed in time unit srcUnit to a time duration expressed in dstUnit and returns the result of the conversion.
convert_BigDecimal_to_BigInteger(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_byte(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_Byte(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_double(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_Double(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_float(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_Float(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_int(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_Integer(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_long(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_Long(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_short(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigDecimal_to_Short(BigDecimal) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_BigDecimal(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_byte(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_Byte(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_double(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_Double(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_float(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_Float(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_int(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_Integer(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_long(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_Long(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_short(BigInteger) - Static method in class flanagan.math.Conv
 
convert_BigInteger_to_Short(BigInteger) - Static method in class flanagan.math.Conv
 
convert_byte_to_BigDecimal(byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_BigDecimal(Byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_BigInteger(byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_BigInteger(Byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_double(byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_Double(byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_double(Byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_Double(Byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_float(byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_Float(byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_float(Byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_Float(Byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_int(byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_int(Byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_Integer(byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_Integer(Byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_long(byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_Long(byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_long(Byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_Long(Byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_short(byte) - Static method in class flanagan.math.Conv
 
convert_byte_to_Short(byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_short(Byte) - Static method in class flanagan.math.Conv
 
convert_Byte_to_Short(Byte) - Static method in class flanagan.math.Conv
 
convert_Complex_to_Phasor(Complex) - Static method in class flanagan.math.Conv
 
convert_double_to_BigDecimal(double) - Static method in class flanagan.math.Conv
 
convert_Double_to_BigDecimal(Double) - Static method in class flanagan.math.Conv
 
convert_double_to_BigInteger(double) - Static method in class flanagan.math.Conv
 
convert_Double_to_BigInteger(Double) - Static method in class flanagan.math.Conv
 
convert_double_to_BigInteger(float) - Static method in class flanagan.math.Conv
 
convert_double_to_byte(double) - Static method in class flanagan.math.Conv
 
convert_double_to_Byte(double) - Static method in class flanagan.math.Conv
 
convert_Double_to_byte(Double) - Static method in class flanagan.math.Conv
 
convert_Double_to_Byte(Double) - Static method in class flanagan.math.Conv
 
convert_double_to_float(double) - Static method in class flanagan.math.Conv
 
convert_double_to_Float(double) - Static method in class flanagan.math.Conv
 
convert_Double_to_float(Double) - Static method in class flanagan.math.Conv
 
convert_Double_to_Float(Double) - Static method in class flanagan.math.Conv
 
convert_double_to_int(double) - Static method in class flanagan.math.Conv
 
convert_Double_to_int(Double) - Static method in class flanagan.math.Conv
 
convert_double_to_Integer(double) - Static method in class flanagan.math.Conv
 
convert_Double_to_Integer(Double) - Static method in class flanagan.math.Conv
 
convert_double_to_long(double) - Static method in class flanagan.math.Conv
 
convert_double_to_Long(double) - Static method in class flanagan.math.Conv
 
convert_Double_to_long(Double) - Static method in class flanagan.math.Conv
 
convert_Double_to_Long(Double) - Static method in class flanagan.math.Conv
 
convert_double_to_short(double) - Static method in class flanagan.math.Conv
 
convert_double_to_Short(double) - Static method in class flanagan.math.Conv
 
convert_Double_to_short(Double) - Static method in class flanagan.math.Conv
 
convert_Double_to_Short(Double) - Static method in class flanagan.math.Conv
 
convert_float_to_BigDecimal(float) - Static method in class flanagan.math.Conv
 
convert_Float_to_BigDecimal(Float) - Static method in class flanagan.math.Conv
 
convert_Float_to_BigInteger(Float) - Static method in class flanagan.math.Conv
 
convert_float_to_byte(float) - Static method in class flanagan.math.Conv
 
convert_float_to_Byte(float) - Static method in class flanagan.math.Conv
 
convert_Float_to_byte(Float) - Static method in class flanagan.math.Conv
 
convert_Float_to_Byte(Float) - Static method in class flanagan.math.Conv
 
convert_float_to_double(float) - Static method in class flanagan.math.Conv
 
convert_float_to_Double(float) - Static method in class flanagan.math.Conv
 
convert_Float_to_double(Float) - Static method in class flanagan.math.Conv
 
convert_Float_to_Double(Float) - Static method in class flanagan.math.Conv
 
convert_float_to_int(float) - Static method in class flanagan.math.Conv
 
convert_Float_to_int(Float) - Static method in class flanagan.math.Conv
 
convert_float_to_Integer(float) - Static method in class flanagan.math.Conv
 
convert_Float_to_Integer(Float) - Static method in class flanagan.math.Conv
 
convert_float_to_long(float) - Static method in class flanagan.math.Conv
 
convert_float_to_Long(float) - Static method in class flanagan.math.Conv
 
convert_Float_to_long(Float) - Static method in class flanagan.math.Conv
 
convert_Float_to_Long(Float) - Static method in class flanagan.math.Conv
 
convert_float_to_short(float) - Static method in class flanagan.math.Conv
 
convert_float_to_Short(float) - Static method in class flanagan.math.Conv
 
convert_Float_to_short(Float) - Static method in class flanagan.math.Conv
 
convert_Float_to_Short(Float) - Static method in class flanagan.math.Conv
 
convert_int_to_BigDecimal(int) - Static method in class flanagan.math.Conv
 
convert_int_to_BigInteger(int) - Static method in class flanagan.math.Conv
 
convert_int_to_byte(int) - Static method in class flanagan.math.Conv
 
convert_int_to_Byte(int) - Static method in class flanagan.math.Conv
 
convert_int_to_double(int) - Static method in class flanagan.math.Conv
 
convert_int_to_Double(int) - Static method in class flanagan.math.Conv
 
convert_int_to_float(int) - Static method in class flanagan.math.Conv
 
convert_int_to_Float(int) - Static method in class flanagan.math.Conv
 
convert_int_to_long(int) - Static method in class flanagan.math.Conv
 
convert_int_to_Long(int) - Static method in class flanagan.math.Conv
 
convert_int_to_short(int) - Static method in class flanagan.math.Conv
 
convert_int_to_Short(int) - Static method in class flanagan.math.Conv
 
convert_Integer_to_BigDecimal(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_BigInteger(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_byte(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_Byte(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_double(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_Double(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_float(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_Float(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_long(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_Long(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_short(Integer) - Static method in class flanagan.math.Conv
 
convert_Integer_to_Short(Integer) - Static method in class flanagan.math.Conv
 
convert_long_to_BigDecimal(long) - Static method in class flanagan.math.Conv
 
convert_Long_to_BigDecimal(Long) - Static method in class flanagan.math.Conv
 
convert_long_to_BigInteger(long) - Static method in class flanagan.math.Conv
 
convert_Long_to_BigInteger(Long) - Static method in class flanagan.math.Conv
 
convert_long_to_byte(long) - Static method in class flanagan.math.Conv
 
convert_long_to_Byte(long) - Static method in class flanagan.math.Conv
 
convert_Long_to_byte(Long) - Static method in class flanagan.math.Conv
 
convert_Long_to_Byte(Long) - Static method in class flanagan.math.Conv
 
convert_long_to_double(long) - Static method in class flanagan.math.Conv
 
convert_long_to_Double(long) - Static method in class flanagan.math.Conv
 
convert_Long_to_double(Long) - Static method in class flanagan.math.Conv
 
convert_Long_to_Double(Long) - Static method in class flanagan.math.Conv
 
convert_long_to_float(long) - Static method in class flanagan.math.Conv
 
convert_long_to_Float(long) - Static method in class flanagan.math.Conv
 
convert_Long_to_float(Long) - Static method in class flanagan.math.Conv
 
convert_Long_to_Float(Long) - Static method in class flanagan.math.Conv
 
convert_long_to_int(long) - Static method in class flanagan.math.Conv
 
convert_Long_to_int(Long) - Static method in class flanagan.math.Conv
 
convert_long_to_Integer(long) - Static method in class flanagan.math.Conv
 
convert_Long_to_Integer(Long) - Static method in class flanagan.math.Conv
 
convert_long_to_short(long) - Static method in class flanagan.math.Conv
 
convert_long_to_Short(long) - Static method in class flanagan.math.Conv
 
convert_Long_to_short(Long) - Static method in class flanagan.math.Conv
 
convert_Long_to_Short(Long) - Static method in class flanagan.math.Conv
 
convert_Phasor_to_Complex(Phasor) - Static method in class flanagan.math.Conv
 
convert_short_to_BigDecimal(short) - Static method in class flanagan.math.Conv
 
convert_Short_to_BigDecimal(Short) - Static method in class flanagan.math.Conv
 
convert_short_to_BigInteger(short) - Static method in class flanagan.math.Conv
 
convert_Short_to_BigInteger(Short) - Static method in class flanagan.math.Conv
 
convert_short_to_byte(short) - Static method in class flanagan.math.Conv
 
convert_short_to_Byte(short) - Static method in class flanagan.math.Conv
 
convert_Short_to_byte(Short) - Static method in class flanagan.math.Conv
 
convert_Short_to_Byte(Short) - Static method in class flanagan.math.Conv
 
convert_short_to_double(short) - Static method in class flanagan.math.Conv
 
convert_short_to_Double(short) - Static method in class flanagan.math.Conv
 
convert_Short_to_double(Short) - Static method in class flanagan.math.Conv
 
convert_Short_to_Double(Short) - Static method in class flanagan.math.Conv
 
convert_short_to_float(short) - Static method in class flanagan.math.Conv
 
convert_short_to_Float(short) - Static method in class flanagan.math.Conv
 
convert_Short_to_float(Short) - Static method in class flanagan.math.Conv
 
convert_Short_to_Float(Short) - Static method in class flanagan.math.Conv
 
convert_short_to_int(short) - Static method in class flanagan.math.Conv
 
convert_Short_to_int(Short) - Static method in class flanagan.math.Conv
 
convert_short_to_Integer(short) - Static method in class flanagan.math.Conv
 
convert_Short_to_Integer(Short) - Static method in class flanagan.math.Conv
 
convert_short_to_long(short) - Static method in class flanagan.math.Conv
 
convert_short_to_Long(short) - Static method in class flanagan.math.Conv
 
convert_Short_to_long(Short) - Static method in class flanagan.math.Conv
 
convert_Short_to_Long(Short) - Static method in class flanagan.math.Conv
 
convertBigWtoLittleW() - Method in class flanagan.analysis.Stat
 
convertBigWtoLittleW(double[]) - Static method in class flanagan.analysis.Stat
 
convertBigWtoLittleW(float[]) - Static method in class flanagan.analysis.Stat
 
convertBigWtoLittleW(Complex[]) - Static method in class flanagan.analysis.Stat
 
convertBigWtoLittleW(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
convertBigWtoLittleW(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
convertDoubleParameter(String, double) - Static method in class jhplot.HCellular
Converts a String parameter into a double parameter.
Converter - Class in cern.hep.aida.ref
Histogram conversions, for example to String and XML format; This class requires the Colt distribution, whereas the rest of the package is entirelly stand-alone.
Converter() - Constructor for class cern.hep.aida.ref.Converter
Creates a new histogram converter.
convertFromInnerType(ListWithStat.Node<E>) - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
 
convertFromInnerType(IE) - Method in class umontreal.iro.lecuyer.util.TransformingList
Converts an element in the inner list to an element of the outer type.
convertIntParameter(String, int) - Static method in class jhplot.HCellular
Converts a String parameter into an integer parameter.
convertToHighest() - Method in class flanagan.analysis.Stat
 
convertToHighest() - Method in class flanagan.math.ArrayMaths
 
convertToHistogram() - Method in class hep.aida.ref.histogram.Cloud
Convert the ICloud to an IHistogram using the default number of bins.
convertToHistogram() - Method in class hep.aida.ref.histogram.Cloud1D
 
convertToHistogram() - Method in class hep.aida.ref.histogram.Cloud2D
 
convertToHistogram() - Method in class hep.aida.ref.histogram.Cloud3D
 
convertToInnerType(E) - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
 
convertToInnerType(OE) - Method in class umontreal.iro.lecuyer.util.TransformingList
Converts an element of the outer type to an element for the inner list.
coordinate(int) - Method in class hep.aida.ref.histogram.DataPoint
 
coordToIndex(double) - Method in class cern.hep.aida.ref.FixedAxis
 
coordToIndex(double) - Method in class cern.hep.aida.ref.VariableAxis
 
coordToIndex(double) - Method in class hep.aida.ref.histogram.FixedAxis
Get the bin's index corresponding to an axis's value.
coordToIndex(double) - Method in class hep.aida.ref.histogram.Histogram1D
Convenience method, equivalent to axis().coordToIndex(coord).
coordToIndex(double) - Method in class hep.aida.ref.histogram.Profile1D
 
coordToIndex(double) - Method in class hep.aida.ref.histogram.VariableAxis
 
coordToIndex(double) - Method in interface hep.aida.tdouble.DoubleIAxis
Converts a coordinate on the axis to a bin number.
coordToIndex(double) - Method in class hep.aida.tdouble.ref.DoubleFixedAxis
 
coordToIndex(double) - Method in class hep.aida.tdouble.ref.DoubleVariableAxis
 
coordToIndex(float) - Method in interface hep.aida.tfloat.FloatIAxis
Converts a coordinate on the axis to a bin number.
coordToIndex(float) - Method in class hep.aida.tfloat.ref.FloatFixedAxis
 
coordToIndex(float) - Method in class hep.aida.tfloat.ref.FloatVariableAxis
 
coordToIndexX(double) - Method in class hep.aida.ref.histogram.Histogram2D
Convenience method, equivalent to xAxis().coordToIndex(coord).
coordToIndexX(double) - Method in class hep.aida.ref.histogram.Histogram3D
Convenience method, equivalent to xAxis().coordToIndex(coord).
coordToIndexX(double) - Method in class hep.aida.ref.histogram.Profile2D
 
coordToIndexY(double) - Method in class hep.aida.ref.histogram.Histogram2D
Convenience method, equivalent to yAxis().coordToIndex(coord).
coordToIndexY(double) - Method in class hep.aida.ref.histogram.Histogram3D
Convenience method, equivalent to yAxis().coordToIndex(coord).
coordToIndexY(double) - Method in class hep.aida.ref.histogram.Profile2D
 
coordToIndexZ(double) - Method in class hep.aida.ref.histogram.Histogram3D
Convenience method, equivalent to zAxis().coordToIndex(coord).
copy() - Method in class cern.colt.bitvector.BitMatrix
Returns a shallow clone of the receiver; calls clone() and casts the result.
copy() - Method in class cern.colt.bitvector.BitVector
Returns a deep copy of the receiver; calls clone() and casts the result.
copy() - Method in class cern.colt.list.BooleanArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.ByteArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.CharArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.DoubleArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.FloatArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.IntArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.LongArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.ObjectArrayList
Returns a copy of the receiver; call clone() and casts the result.
copy() - Method in class cern.colt.list.ShortArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.tboolean.BooleanArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.tbyte.ByteArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.tchar.CharArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.tdouble.DoubleArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.tfloat.FloatArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.tint.IntArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.tlong.LongArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.list.tobject.ObjectArrayList
Returns a copy of the receiver; call clone() and casts the result.
copy() - Method in class cern.colt.list.tshort.ShortArrayList
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.AbstractDoubleIntMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.AbstractIntDoubleMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.AbstractIntIntMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.AbstractIntObjectMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.AbstractLongObjectMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tint.AbstractIntIntMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tlong.AbstractIntLongMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tlong.AbstractLongIntMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tlong.AbstractLongLongMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Returns a deep copy of the receiver; uses clone() and casts the result.
copy() - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tbit.BitMatrix
Returns a shallow clone of the receiver; calls clone() and casts the result.
copy() - Method in class cern.colt.matrix.tbit.BitVector
Returns a deep copy of the receiver; calls clone() and casts the result.
copy() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tint.IntMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a deep copy of the receiver.
copy() - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a deep copy of the receiver.
copy(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
copy() - Method in class flanagan.analysis.ErrorProp
 
copy(ErrorProp[]) - Static method in class flanagan.analysis.ErrorProp
 
copy(ErrorProp[][]) - Static method in class flanagan.analysis.ErrorProp
 
copy() - Method in class flanagan.analysis.Stat
 
copy() - Method in class flanagan.math.ArrayMaths
 
copy(Matrix) - Static method in class flanagan.math.Matrix
 
copy() - Method in class flanagan.math.Matrix
 
copy() - Method in class hephysics.particle.HEParticle
Make an exact copy of this particle
copy() - Method in class hephysics.particle.LParticle
Make an exact copy of this particle
copy(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
New copy
copy() - Method in class hephysics.vec.HepLorentzVector
Make exact copy
copy() - Method in class jhplot.bsom.Matrix
Copy the matrix.
copy() - Method in class jhplot.H1D
Make a copy of the data holder
copy(String) - Method in class jhplot.H1D
Get exact copy of the current histogram.
copy(String) - Method in class jhplot.H2D
Get exact copy of the current histogram.
copy() - Method in class jhplot.H2D
Make a copy of the data holder
copy() - Method in class jhplot.HProf1D
Make a copy of the data holder
copy(String) - Method in class jhplot.HProf1D
Get exact copy of the current histogram.
copy() - Method in class jhplot.jadraw.JaAxes
Returns an exact copy of this Label.
copy() - Method in class jhplot.jadraw.JaBlob
Returns an exact copy of this JaBlob.
copy() - Method in class jhplot.jadraw.JaBox
Returns an exact copy of this Label.
copy() - Method in class jhplot.jadraw.JaFArc
Returns an exact copy of this JaFArc.
copy() - Method in class jhplot.jadraw.JaFLine
Returns an exact copy of this JaFLine.
copy() - Method in class jhplot.jadraw.JaFLoop
Returns an exact copy of this JaFLoop.
copy() - Method in class jhplot.jadraw.JaGArc
Returns an exact copy of this JaGArc.
copy() - Method in class jhplot.jadraw.JaGlArc
Returns an exact copy of this JaGlArc.
copy() - Method in class jhplot.jadraw.JaGLine
Returns an exact copy of this JaGLine.
copy() - Method in class jhplot.jadraw.JaGlLine
Returns an exact copy of this JaGlLine.
copy() - Method in class jhplot.jadraw.JaGlLoop
Returns an exact copy of this JaGlLoop.
copy() - Method in class jhplot.jadraw.JaGLoop
Returns an exact copy of this JaGLoop.
copy() - Method in class jhplot.jadraw.JaKey
Returns an exact copy of this label.
copy() - Method in class jhplot.jadraw.JaLatexText
Returns an exact copy of this JaLatexText.
copy() - Method in class jhplot.jadraw.JaLine
Returns an exact copy of this JaFLine.
copy(JaLoopObject) - Method in class jhplot.jadraw.JaLoopObject
Returns an exact copy of this JaxoLoop.
COPY - Static variable in class jhplot.jadraw.JaObject
An integer that indicates the current edit mode COPY.
copy() - Method in class jhplot.jadraw.JaObject
Returns an exact copy of the given JaObject.
copy() - Method in class jhplot.jadraw.JaPArc
Returns an exact copy of this JaPArc.
copy() - Method in class jhplot.jadraw.JaPLine
Returns an exact copy of this JaPLine.
copy() - Method in class jhplot.jadraw.JaPLoop
Returns an exact copy of this JaPLoop.
copy() - Method in class jhplot.jadraw.JaSArc
Returns an exact copy of this JaSArc.
copy() - Method in class jhplot.jadraw.JaSLine
Returns an exact copy of this JaSLine.
copy() - Method in class jhplot.jadraw.JaSLoop
Returns an exact copy of this JaSLoop.
copy() - Method in class jhplot.jadraw.JaText
Returns an exact copy of this label.
copy() - Method in class jhplot.jadraw.JaTextBox
Returns an exact copy of this Label.
copy(JaVertex) - Method in class jhplot.jadraw.JaVertex
Returns an exact copy of this JaVertex.
copy() - Method in class jhplot.jadraw.JaVertexT1
Returns an exact copy of this JaVertexT1.
copy() - Method in class jhplot.jadraw.JaVertexT2
Returns an exact copy of this JaVertexT1.
copy() - Method in class jhplot.jadraw.JaVertexT3
Returns an exact copy of this JaVertexT3.
copy() - Method in class jhplot.jadraw.JaVertexT4
Returns an exact copy of this JaVertexT4.
copy() - Method in class jhplot.jadraw.JaVertexT5
Returns an exact copy of this JaVertexT1.
copy() - Method in class jhplot.jadraw.JaVertexT6
Returns an exact copy of this JaVertexT6.
copy() - Method in class jhplot.jadraw.JaZigZagLine
Returns an exact copy of this JaZigZagLine.
copy(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(long[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(float[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns a copy of the array.
copy(double[]) - Static method in class jhplot.math.DoubleArray
Generate a copy of an array
copy(double[][]) - Static method in class jhplot.math.DoubleArray
Generate a copy of a matrix
copy(int[]) - Static method in class jhplot.math.IntegerArray
 
copy(int[][]) - Static method in class jhplot.math.IntegerArray
 
copy(ValueErr) - Static method in class jhplot.math.ValueErr
Copy value
copy() - Method in class jhplot.math.ValueErr
Copy a single ValueErr
copy(ValueErr[]) - Static method in class jhplot.math.ValueErr
 
copy(ValueErr[][]) - Static method in class jhplot.math.ValueErr
Deep copy a 2D array of ValueErr numbers
copy() - Method in class jhplot.P0D
Get a copy of the current holder
copy(String) - Method in class jhplot.P0D
Create an exact copy of the current P0D.
copy() - Method in class jhplot.P0I
Get a copy of the current holder
copy(String) - Method in class jhplot.P0I
Create an exact copy of the current P0I.
copy(String) - Method in class jhplot.P1D
create an exact of the current holder
copy() - Method in class jhplot.P1D
Make a new data holder with the same title from the current one.
copy() - Method in class jhplot.P2D
Get a copy of the current holder
copy(String) - Method in class jhplot.P2D
create an exact of the current holder
copy(String) - Method in class jhplot.PND
Create an exact copy of the current P0D.
copy(String) - Method in class jhplot.PNI
Create an exact copy of the current P0D.
copy(Vector3d) - Method in class jhplot.v3d.Vector3d
 
copy() - Method in class jhpro.stat.DataKeeper
Make a copy
copy() - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.AbstractRealVector
Returns a (deep) copy of this vector.
copy() - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.ArrayFieldVector
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.ArrayRealVector
Returns a (deep) copy of this vector.
copy() - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Create a new BigMatrix which is a copy of this.
copy() - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns a (deep) copy of this.
copy() - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns a (deep) copy of this.
copy() - Method in interface org.apache.commons.math.linear.FieldVector
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.OpenMapRealVector
Returns a (deep) copy of this vector.
copy() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Returns a (deep) copy of this.
copy() - Method in interface org.apache.commons.math.linear.RealVector
Returns a (deep) copy of this vector.
copy() - Method in class org.apache.commons.math.linear.SparseFieldMatrix
Returns a (deep) copy of this.
copy() - Method in class org.apache.commons.math.linear.SparseFieldVector
Returns a (deep) copy of this.
copy() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Copy the instance.
copy() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Copy the instance.
copy() - Method in interface org.apache.commons.math.ode.sampling.StepInterpolator
Copy the instance.
copy() - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy() - Method in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns a copy of this DescriptiveStatistics instance with the same internal state.
copy(DescriptiveStatistics, DescriptiveStatistics) - Static method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Returns a copy of the statistic with the same internal state.
copy(FirstMoment, FirstMoment) - Static method in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.FourthMoment
Returns a copy of the statistic with the same internal state.
copy(FourthMoment, FourthMoment) - Static method in class org.apache.commons.math.stat.descriptive.moment.FourthMoment
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Returns a copy of the statistic with the same internal state.
copy(GeometricMean, GeometricMean) - Static method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Returns a copy of the statistic with the same internal state.
copy(Kurtosis, Kurtosis) - Static method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
Returns a copy of the statistic with the same internal state.
copy(Mean, Mean) - Static method in class org.apache.commons.math.stat.descriptive.moment.Mean
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.SecondMoment
Returns a copy of the statistic with the same internal state.
copy(SecondMoment, SecondMoment) - Static method in class org.apache.commons.math.stat.descriptive.moment.SecondMoment
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Returns a copy of the statistic with the same internal state.
copy(SemiVariance, SemiVariance) - Static method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
Returns a copy of the statistic with the same internal state.
copy(Skewness, Skewness) - Static method in class org.apache.commons.math.stat.descriptive.moment.Skewness
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns a copy of the statistic with the same internal state.
copy(StandardDeviation, StandardDeviation) - Static method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
Returns a copy of the statistic with the same internal state.
copy(ThirdMoment, ThirdMoment) - Static method in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns a copy of the statistic with the same internal state.
copy(Variance, Variance) - Static method in class org.apache.commons.math.stat.descriptive.moment.Variance
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.rank.Max
Returns a copy of the statistic with the same internal state.
copy(Max, Max) - Static method in class org.apache.commons.math.stat.descriptive.rank.Max
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.rank.Min
Returns a copy of the statistic with the same internal state.
copy(Min, Min) - Static method in class org.apache.commons.math.stat.descriptive.rank.Min
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Returns a copy of the statistic with the same internal state.
copy(Percentile, Percentile) - Static method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Copies source to dest.
copy() - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy() - Method in class org.apache.commons.math.stat.descriptive.summary.Product
Returns a copy of the statistic with the same internal state.
copy(Product, Product) - Static method in class org.apache.commons.math.stat.descriptive.summary.Product
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
Returns a copy of the statistic with the same internal state.
copy(Sum, Sum) - Static method in class org.apache.commons.math.stat.descriptive.summary.Sum
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Returns a copy of the statistic with the same internal state.
copy(SumOfLogs, SumOfLogs) - Static method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Returns a copy of the statistic with the same internal state.
copy(SumOfSquares, SumOfSquares) - Static method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns a copy of this SummaryStatistics instance with the same internal state.
copy(SummaryStatistics, SummaryStatistics) - Static method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Returns a copy of this SynchronizedDescriptiveStatistics instance with the same internal state.
copy(SynchronizedDescriptiveStatistics, SynchronizedDescriptiveStatistics) - Static method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Copies source to dest.
copy() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns a copy of this SynchronizedSummaryStatistics instance with the same internal state.
copy(SynchronizedSummaryStatistics, SynchronizedSummaryStatistics) - Static method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Copies source to dest.
copy() - Method in interface org.apache.commons.math.stat.descriptive.UnivariateStatistic
Returns a copy of the statistic with the same internal state.
copy(ResizableDoubleArray, ResizableDoubleArray) - Static method in class org.apache.commons.math.util.ResizableDoubleArray
Copies source to dest, copying the underlying data, so dest is a new, independent copy of source.
copy() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns a copy of the ResizableDoubleArray.
copyFile(File, File) - Static method in class jhplot.math.io.DataFile
 
copyFile(File, File) - Static method in class jhplot.v3d.Util
Copies the contents of any disk file to a specified output file.
copyLinePars(LinePars) - Method in class jhplot.DrawOptions
Copy drawing options.
copyObject(Object) - Static method in class flanagan.math.Conv
 
copyObject(Object) - Static method in class flanagan.math.Fmath
 
copyPos(Position) - Method in class jhplot.v3d.Position
 
copysign(Dfp, Dfp) - Static method in class org.apache.commons.math.dfp.Dfp
Creates an instance that is the same as x except that it has the sign of y.
copySign(double, double) - Static method in class org.apache.commons.math.util.FastMath
Returns the first argument with the sign of the second argument.
copySign(float, float) - Static method in class org.apache.commons.math.util.FastMath
Returns the first argument with the sign of the second argument.
copySubMatrix(int, int, int, int, T[][]) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Copy a submatrix.
copySubMatrix(int[], int[], T[][]) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Copy a submatrix.
copySubMatrix(int, int, int, int, double[][]) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Copy a submatrix.
copySubMatrix(int[], int[], double[][]) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Copy a submatrix.
copySubMatrix(int, int, int, int, T[][]) - Method in interface org.apache.commons.math.linear.FieldMatrix
Copy a submatrix.
copySubMatrix(int[], int[], T[][]) - Method in interface org.apache.commons.math.linear.FieldMatrix
Copy a submatrix.
copySubMatrix(int, int, int, int, double[][]) - Method in interface org.apache.commons.math.linear.RealMatrix
Copy a submatrix.
copySubMatrix(int[], int[], double[][]) - Method in interface org.apache.commons.math.linear.RealMatrix
Copy a submatrix.
COR - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Correlation
core() - Method in class hep.aida.ref.function.BaseModelFunction
 
coreChanged() - Method in interface hep.aida.ref.function.FunctionCoreListener
 
corpusChristi() - Method in class flanagan.math.TimeAndDate
 
corpusChristi(int) - Method in class flanagan.math.TimeAndDate
 
corrCoeff(double[], double[]) - Static method in class flanagan.analysis.Stat
 
corrCoeff(float[], float[]) - Static method in class flanagan.analysis.Stat
 
corrCoeff(int[], int[]) - Static method in class flanagan.analysis.Stat
 
corrCoeff(double[], double[], double[]) - Static method in class flanagan.analysis.Stat
 
corrCoeff(int, int, int, int) - Static method in class flanagan.analysis.Stat
 
corrCoeff(int[][]) - Static method in class flanagan.analysis.Stat
 
corrCoeffPDF(double, int) - Static method in class flanagan.analysis.Stat
 
corrCoeffPdf(double, int) - Static method in class flanagan.analysis.Stat
 
corrCoeffProb(double, int) - Static method in class flanagan.analysis.Stat
 
correlate(double[]) - Method in class flanagan.math.FourierTransform
 
correlate(double[], double[]) - Method in class flanagan.math.FourierTransform
 
correlatedGaussianArrays(double, double, double, double, double, int) - Method in class flanagan.math.PsRandom
 
correlatedNormalArrays(double, double, double, double, double, int) - Method in class flanagan.math.PsRandom
 
CorrelatedRandomVectorGenerator - Class in org.apache.commons.math.random
A RandomVectorGenerator that generates vectors with with correlated components.
CorrelatedRandomVectorGenerator(double[], RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Simple constructor.
CorrelatedRandomVectorGenerator(RealMatrix, double, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Simple constructor.
correlation(DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Modifies the given covariance matrix to be a correlation matrix (in-place).
correlation(DoubleMatrix2D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Modifies the given covariance matrix to be a correlation matrix (in-place).
correlation(FloatMatrix2D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Modifies the given covariance matrix to be a correlation matrix (in-place).
correlation(DynamicBin1D) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the correlation of two bins, which is corr(x,y) = covariance(x,y) / (stdDev(x)*stdDev(y)) (Pearson's correlation coefficient).
correlation(DoubleArrayList, double, DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the correlation of two data sequences.
correlation(DoubleArrayList, double, DoubleArrayList, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the correlation of two data sequences.
correlation(FloatArrayList, float, FloatArrayList, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the correlation of two data sequences.
correlation(DynamicDoubleBin1D) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the correlation of two bins, which is corr(x,y) = covariance(x,y) / (stdDev(x)*stdDev(y)) (Pearson's correlation coefficient).
correlation(DynamicFloatBin1D) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the correlation of two bins, which is corr(x,y) = covariance(x,y) / (stdDev(x)*stdDev(y)) (Pearson's correlation coefficient).
correlation(double[], double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the (linear) correlation between two arrays.
correlation(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the (linear) correlation between two arrays.
correlation(double[], double[]) - Static method in class jhplot.math.StatisticSample
Correlation coefficient, covariance(v1, v2) / Math.sqrt(variance(v1) * variance(v2)
correlation(double[][], double[][]) - Static method in class jhplot.math.StatisticSample
Correlation coefficient, covariance(v1, v2) / Math.sqrt(variance(v1) * variance(v2)
correlation(double[][]) - Static method in class jhplot.math.StatisticSample
Correlation
correlation(P0D) - Method in class jhplot.P0D
Returns the correlation coefficient.
correlation(P0I) - Method in class jhplot.P0I
Returns the correlation coefficient.
correlation(double[], double[]) - Static method in class jhplot.stat.Statistics
Correlation coefficient, covariance(v1, v2) / Math.sqrt(variance(v1) * variance(v2)
correlation(double[][], double[][]) - Static method in class jhplot.stat.Statistics
Correlation coefficient, covariance(v1, v2) / Math.sqrt(variance(v1) * variance(v2)
correlation(double[][]) - Static method in class jhplot.stat.Statistics
Correlation
correlation(double[], double[]) - Method in class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Computes the Pearson's product-moment correlation coefficient between the two arrays.
correlation(double[], double[]) - Method in class org.apache.commons.math.stat.correlation.SpearmansCorrelation
Computes the Spearman's rank correlation coefficient between the two arrays.
correlation(int, int) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
Returns the empirical correlation between the observations in tallies with indices i and j.
correlation(DoubleMatrix2D) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
Similar to covariance for computing the sample correlation matrix.
correlationMatrix() - Method in class flanagan.analysis.PCA
 
correlationObject() - Method in class hep.aida.ref.fitter.fitmethod.AbstractFitMethod
 
cos - Static variable in class cern.jet.math.Functions
Function that returns Math.cos(a).
cos(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
cos - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
cos - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.cos(a).
cos(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
cos - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
cos - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.cos(a).
cos(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
cos(double, double, double, double, double, double) - Static method in class flanagan.math.Fmath
 
cos(double, double, double) - Static method in class flanagan.math.Fmath
 
cos(double) - Static method in class flanagan.math.Fmath
 
cos() - Method in class jhplot.math.Complex
Cosine of this Complex number (doesn't change this Complex number).
cos(ValueErr) - Static method in class jhplot.math.ValueErr
Cosine of a value wth error
COS - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.cos method wrapped as a ComposableFunction.
cos() - Method in class org.apache.commons.math.complex.Complex
Compute the cosine of this complex number.
cos(Dfp) - Static method in class org.apache.commons.math.dfp.DfpMath
computes the cosine of the argument.
cos(double) - Static method in class org.apache.commons.math.util.FastMath
Cosine function
cosh(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
cosh(double) - Static method in class flanagan.math.Fmath
 
cosh() - Method in class jhplot.math.Complex
Hyperbolic cosine of this Complex number (doesn't change this Complex number).
cosh(double) - Static method in class jhplot.math.num.special.Trigonometric
Returns the hyperbolic cosine of x.
cosh(ValueErr) - Static method in class jhplot.math.ValueErr
Hyperbolic cosine
COSH - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.cosh method wrapped as a ComposableFunction.
cosh() - Method in class org.apache.commons.math.complex.Complex
Compute the hyperbolic cosine of this complex number.
cosh(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the hyperbolic cosine of a number.
cosh(double) - Static method in class org.apache.commons.math.util.MathUtils
Returns the hyperbolic cosine of x.
cosPhi() - Method in class hephysics.vec.SpacePoint
cos(phi)
cosTheta() - Method in class hephysics.vec.Hep3Vector
cosTheta
cosTheta(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Cosine Theta
cosTheta() - Method in class hephysics.vec.HepLorentzVector
cosTheta
cosTheta() - Method in class hephysics.vec.SpacePoint
cos(theta)
cosTheta(Hep3Vector) - Static method in class hephysics.vec.VecOp
 
cot(double) - Static method in class flanagan.math.Fmath
 
coth(double) - Static method in class flanagan.math.Fmath
 
coulomb - Static variable in class cern.clhep.Units
 
countSortFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Sorts the specified range of the receiver into ascending numerical order (false < true).
countSortFromTo(int, int) - Method in class cern.colt.list.ByteArrayList
Sorts the specified range of the receiver into ascending numerical order.
countSortFromTo(int, int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Sorts the specified range of the receiver into ascending numerical order (false < true).
countSortFromTo(int, int) - Method in class cern.colt.list.tbyte.ByteArrayList
Sorts the specified range of the receiver into ascending numerical order.
covariance(DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Constructs and returns the covariance matrix of the given matrix.
covariance(DoubleMatrix2D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Constructs and returns the covariance matrix of the given matrix.
covariance(FloatMatrix2D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Constructs and returns the covariance matrix of the given matrix.
covariance(DynamicBin1D) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the covariance of two bins, which is cov(x,y) = (1/size()) * Sum((x[i]-mean(x)) * (y[i]-mean(y))).
covariance(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the covariance of two data sequences, which is cov(x,y) = (1/(size()-1)) * Sum((x[i]-mean(x)) * (y[i]-mean(y))).
covariance(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the covariance of two data sequences, which is cov(x,y) = (1/(size()-1)) * Sum((x[i]-mean(x)) * (y[i]-mean(y))) .
covariance(FloatArrayList, FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the covariance of two data sequences, which is cov(x,y) = (1/(size()-1)) * Sum((x[i]-mean(x)) * (y[i]-mean(y))) .
covariance(double[], double[]) - Static method in class flanagan.analysis.Stat
 
covariance(float[], float[]) - Static method in class flanagan.analysis.Stat
 
covariance(int[], int[]) - Static method in class flanagan.analysis.Stat
 
covariance(long[], long[]) - Static method in class flanagan.analysis.Stat
 
covariance(double[], double[], double[]) - Static method in class flanagan.analysis.Stat
 
covariance(DynamicDoubleBin1D) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the covariance of two bins, which is cov(x,y) = (1/size()) * Sum((x[i]-mean(x)) * (y[i]-mean(y))).
covariance(DynamicFloatBin1D) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the covariance of two bins, which is cov(x,y) = (1/size()) * Sum((x[i]-mean(x)) * (y[i]-mean(y))).
covariance(double[], double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the covariance.
covariance(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the covariance.
covariance(double[], double[]) - Static method in class jhplot.math.StatisticSample
Covariance
covariance(double[][], double[][]) - Static method in class jhplot.math.StatisticSample
Covariance
covariance(double[][]) - Static method in class jhplot.math.StatisticSample
Covariance
covariance(P0D) - Method in class jhplot.P0D
Returns the covariance
covariance(P0I) - Method in class jhplot.P0I
Returns the covariance
covariance(double[], double[]) - Static method in class jhplot.stat.Statistics
Covariance
covariance(double[][], double[][]) - Static method in class jhplot.stat.Statistics
Covariance
covariance(double[][]) - Static method in class jhplot.stat.Statistics
Covariance
Covariance - Class in org.apache.commons.math.stat.correlation
Computes covariances for pairs of arrays or columns of a matrix.
Covariance() - Constructor for class org.apache.commons.math.stat.correlation.Covariance
Create a Covariance with no data
Covariance(double[][], boolean) - Constructor for class org.apache.commons.math.stat.correlation.Covariance
Create a Covariance matrix from a rectangular array whose columns represent covariates.
Covariance(double[][]) - Constructor for class org.apache.commons.math.stat.correlation.Covariance
Create a Covariance matrix from a rectangular array whose columns represent covariates.
Covariance(RealMatrix, boolean) - Constructor for class org.apache.commons.math.stat.correlation.Covariance
Create a covariance matrix from a matrix whose columns represent covariates.
Covariance(RealMatrix) - Constructor for class org.apache.commons.math.stat.correlation.Covariance
Create a covariance matrix from a matrix whose columns represent covariates.
covariance(double[], double[], boolean) - Method in class org.apache.commons.math.stat.correlation.Covariance
Computes the covariance between the two arrays.
covariance(double[], double[]) - Method in class org.apache.commons.math.stat.correlation.Covariance
Computes the covariance between the two arrays, using the bias-corrected formula.
covariance(int, int) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
Returns the empirical covariance of the observations in tallies with indices i and j.
covariance(DoubleMatrix2D) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
Constructs and returns the sample covariance matrix for the tallies in this list.
covariance(int, int) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTalliesWithCovariance
 
covariance(TallyStore) - Method in class umontreal.iro.lecuyer.stat.TallyStore
Returns the sample covariance of the observations contained in this tally, and the other tally t2.
covarianceMatrix() - Method in class flanagan.analysis.PCA
 
covarianceToCorrelation(RealMatrix) - Method in class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Derives a correlation matrix from a covariance matrix.
covers(double) - Static method in class flanagan.math.Fmath
 
covMatrixElement(int, int) - Method in class hep.aida.ref.fitter.FitResult
 
cp(String, String) - Method in class hep.aida.ref.tree.Tree
Copy an object from a path to another.
cp(String, String, boolean) - Method in class hep.aida.ref.tree.Tree
Copy an object from a path to another.
cramerVonMises(DoubleArrayList) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Computes and returns the Cramér-von Mises statistic WN2.
CramerVonMisesDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Cramér-von Mises distribution (see).
CramerVonMisesDist(int) - Constructor for class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Constructs a Cramér-von Mises distribution for a sample of size n.
create(String) - Method in class cern.colt.matrix.FormerFactory
Constructs and returns a new format instance.
create(String) - Method in class cern.colt.matrix.impl.FormerFactory
Constructs and returns a new format instance.
create(Object) - Static method in class hep.aida.ref.fitter.fitdata.FitDataCreator
 
create(String) - Method in class hep.aida.ref.function.FunctionCatalog
 
create(String, String) - Method in class hep.aida.ref.function.FunctionCatalog
 
create(String, String, int) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, String, int, String) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, int, String) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, int) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, IHistogram1D) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, IHistogram1D, String) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, IHistogram2D) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, IHistogram2D, String) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, IHistogram3D) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, IHistogram3D, String) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, ICloud1D) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, ICloud1D, String) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, ICloud2D) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, ICloud2D, String) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, ICloud3D) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, ICloud3D, String) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, IProfile1D) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, IProfile1D, String) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, IProfile2D) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create(String, IProfile2D, String) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
create() - Method in class hep.aida.ref.tree.TreeFactory
Creates a new tree and associates it with a store.
create(String) - Method in class hep.aida.ref.tree.TreeFactory
Creates a new tree and associates it with a store.
create(String, String) - Method in class hep.aida.ref.tree.TreeFactory
Creates a new tree and associates it with a store.
create(String, String, boolean) - Method in class hep.aida.ref.tree.TreeFactory
Creates a new tree and associates it with a store.
create(String, String, boolean, boolean) - Method in class hep.aida.ref.tree.TreeFactory
Creates a new tree and associates it with a store.
create(String, String, boolean, boolean, String) - Method in class hep.aida.ref.tree.TreeFactory
Creates a new tree and associates it with a store.
create(String, String, String[], Class[], String) - Method in class hep.aida.ref.tuple.TupleFactory
Create an NTuple
create(String, String, String[], Class[]) - Method in class hep.aida.ref.tuple.TupleFactory
 
create(String, String, String, String) - Method in class hep.aida.ref.tuple.TupleFactory
Create an NTuple
create(String, String, String) - Method in class hep.aida.ref.tuple.TupleFactory
 
create1DConnection(Object) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create1DConnection(IHistogram1D) - Method in class hep.aida.ref.fitter.fitdata.FitData
1D connections.
create1DConnection(IProfile1D) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create1DConnection(ICloud1D) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create1DConnection(IDataPointSet, int, int) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create1DConnection(double[], double[], double[]) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create2DConnection(IHistogram2D) - Method in class hep.aida.ref.fitter.fitdata.FitData
2D connections.
create2DConnection(IHistogram2D, int, int) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create2DConnection(IProfile2D) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create2DConnection(IProfile2D, int, int) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create2DConnection(ICloud2D) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create2DConnection(ICloud2D, int, int) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create2DConnection(IDataPointSet, int, int, int) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create3DConnection(IHistogram3D) - Method in class hep.aida.ref.fitter.fitdata.FitData
3D connections.
create3DConnection(IHistogram3D, int, int, int) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create3DConnection(ICloud3D) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create3DConnection(ICloud3D, int, int, int) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
create3DConnection(IDataPointSet, int, int, int, int) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
createAdaptor(RandomGenerator) - Static method in class org.apache.commons.math.random.RandomAdaptor
Factory method to create a Random using the supplied RandomGenerator.
createApproxBSpline(double[], double[], int, int) - Static method in class umontreal.iro.lecuyer.functionfit.BSpline
Returns a B-spline curve of degree degree smoothing (xi, yi), for i = 0,…, n points.
createArithmeticException(String, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.createArithmeticException(Localizable, Object...)
createArithmeticException(Localizable, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Constructs a new ArithmeticException with specified formatted detail message.
createArrayIndexOutOfBoundsException(String, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.createArrayIndexOutOfBoundsException(Localizable, Object...)
createArrayIndexOutOfBoundsException(Localizable, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Constructs a new ArrayIndexOutOfBoundsException with specified formatted detail message.
createBean() - Method in class jhplot.io.csv.bean.HeaderColumnNameMappingStrategy
 
createBean() - Method in interface jhplot.io.csv.bean.MappingStrategy
 
createBigIdentityMatrix(int) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0, replaced by MatrixUtils.createFieldIdentityMatrix(Field, int)
createBigMatrix(double[][]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0 replaced by MatrixUtils.createFieldMatrix(FieldElement[][])
createBigMatrix(BigDecimal[][]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0 replaced by MatrixUtils.createFieldMatrix(FieldElement[][])
createBigMatrix(BigDecimal[][], boolean) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0 replaced by MatrixUtils.createFieldMatrix(FieldElement[][])
createBigMatrix(String[][]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0 replaced by MatrixUtils.createFieldMatrix(FieldElement[][])
createBlocksLayout(Field<T>, int, int) - Static method in class org.apache.commons.math.linear.BlockFieldMatrix
Create a data array in blocks layout.
createBlocksLayout(int, int) - Static method in class org.apache.commons.math.linear.BlockRealMatrix
Create a data array in blocks layout.
createChained(String, String, ITuple[]) - Method in class hep.aida.ref.tuple.TupleFactory
Create a logical chain of ITuples.
createChained(String, String, String[]) - Method in class hep.aida.ref.tuple.TupleFactory
 
createChebyshevPolynomial(int) - Static method in class org.apache.commons.math.analysis.polynomials.PolynomialsUtils
Create a Chebyshev polynomial of the first kind.
createCloud1D(String, String, int, String) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a Cloud1D, and unbinned 1-dimensional Histogram.
createCloud1D(String, String, int) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCloud1D(String, String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCloud1D(String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCloud2D(String, String, int, String) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a Cloud2D, and unbinned 2-dimensional Histogram.
createCloud2D(String, String, int) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCloud2D(String, String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCloud2D(String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCloud3D(String, String, int, String) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a Cloud3D, and unbinned 3-dimensional Histogram.
createCloud3D(String, String, int) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCloud3D(String, String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCloud3D(String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createColumn(ITuple, int) - Static method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory
 
createColumnBigMatrix(double[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0 replaced by MatrixUtils.createColumnFieldMatrix(FieldElement[])
createColumnBigMatrix(BigDecimal[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0 replaced by MatrixUtils.createColumnFieldMatrix(FieldElement[])
createColumnBigMatrix(String[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0 replaced by MatrixUtils.createColumnFieldMatrix(FieldElement[])
createColumnFieldMatrix(T[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a column FieldMatrix using the data from the input array.
createColumnRealMatrix(double[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a column RealMatrix using the data from the input array.
createConcurrentModificationException(String, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.createConcurrentModificationException(Localizable, Object...)
createConcurrentModificationException(Localizable, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Constructs a new ConcurrentModificationException with specified formatted detail message.
createConnection(IDataPointSet, int[], int) - Method in class hep.aida.ref.fitter.fitdata.FitData
Generic connections.
createConnection(ITuple, IEvaluator[]) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
createConnection(ITuple, String[]) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
createContour(IFitData, IFitResult, String, String, int, double) - Method in class hep.aida.ref.fitter.Fitter
 
createContributingStatistics() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Creates and returns a SummaryStatistics whose data will be aggregated with those of this AggregateSummaryStatistics.
createControlEvent(SimProcess) - Method in class umontreal.iro.lecuyer.simprocs.DSOLProcessSimulator
 
createControlEvent(SimProcess) - Method in class umontreal.iro.lecuyer.simprocs.ProcessSimulator
Constructs and returns a new Event object used for synchronization.
createControlEvent(SimProcess) - Method in class umontreal.iro.lecuyer.simprocs.ThreadProcessSimulator
 
createCopy(String, IDataPointSet) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createCopy(String, ICloud1D) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCopy(String, ICloud2D) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCopy(String, ICloud3D) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCopy(String, IHistogram1D) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCopy(String, IHistogram2D) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCopy(String, IHistogram3D) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCopy(String, IProfile1D) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCopy(String, IProfile2D) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createCopy(String, ITuple) - Method in class hep.aida.ref.tuple.TupleFactory
Create a copy of an ITuple.
createDataPointSetFactory(ITree, String) - Method in class hep.aida.ref.BatchAnalysisFactory
 
createEOFException(String, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.createEOFException(Localizable, Object...)
createEOFException(Localizable, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Constructs a new EOFException with specified formatted detail message.
createEvaluator(String) - Method in class hep.aida.ref.tuple.TupleFactory
Create IEvaluator.
createFieldDiagonalMatrix(T[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns a diagonal matrix with specified elements.
createFieldIdentityMatrix(Field<T>, int) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns dimension x dimension identity matrix.
createFieldMatrix(Field<T>, int, int) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns a FieldMatrix with specified dimensions.
createFieldMatrix(T[][]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns a FieldMatrix whose entries are the the values in the the input array.
createFieldVector(T[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a FieldVector using the data from the input array.
createFilter(String) - Method in class hep.aida.ref.tuple.TupleFactory
Create IFilter.
createFilter(String, int, int) - Method in class hep.aida.ref.tuple.TupleFactory
 
createFilter(String, int) - Method in class hep.aida.ref.tuple.TupleFactory
 
createFiltered(String, ITuple, IFilter) - Method in class hep.aida.ref.tuple.TupleFactory
 
createFiltered(String, ITuple, IFilter, String[]) - Method in class hep.aida.ref.tuple.TupleFactory
 
createFitData() - Method in class hep.aida.ref.fitter.FitFactory
 
createFitFactory(String) - Method in class hep.aida.ref.BatchAnalysisFactory
 
createFitter() - Method in class hep.aida.ref.fitter.FitFactory
 
createFitter(String) - Method in class hep.aida.ref.fitter.FitFactory
 
createFitter(String, String) - Method in class hep.aida.ref.fitter.FitFactory
 
createFitter(String, String, String) - Method in class hep.aida.ref.fitter.FitFactory
 
createFolderColumn(String, Tuple, String, Tuple) - Static method in class hep.aida.ref.tuple.Tuple.TupleColumnFactory
 
createForSingleThread() - Static method in class umontreal.iro.lecuyer.util.Chrono
Creates a Chrono instance adapted for a program using a single thread.
createFromCodelet(String) - Method in class hep.aida.ref.function.FunctionCreator
 
createFromCodelet(String, String) - Method in class hep.aida.ref.function.FunctionCreator
 
createFunctionByName(String, String) - Method in class hep.aida.ref.function.FunctionFactory
Create function from a name registered in the catalog.
createFunctionFactory(ITree, String) - Method in class hep.aida.ref.BatchAnalysisFactory
 
createFunctionFromScript(String, int, String, String, String) - Method in class hep.aida.ref.function.FunctionFactory
Create function from script.
createFunctionFromScript(String, int, String, String, String, String) - Method in class hep.aida.ref.function.FunctionFactory
Create function from script.
createGenericFactory(String, String) - Method in class hep.aida.ref.BatchAnalysisFactory
 
createHermitePolynomial(int) - Static method in class org.apache.commons.math.analysis.polynomials.PolynomialsUtils
Create a Hermite polynomial.
createHistogram1D(String, String, int, double, double, String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram1D(String, String, int, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram1D(String, int, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram1D(String, String, double[], String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram1D(String, String, double[]) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram2D(String, String, int, double, double, int, double, double, String) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a IHistogram2D.
createHistogram2D(String, String, int, double, double, int, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram2D(String, int, double, double, int, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram2D(String, String, double[], double[], String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram2D(String, String, double[], double[]) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram3D(String, String, int, double, double, int, double, double, int, double, double, String) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a IHistogram3D.
createHistogram3D(String, String, int, double, double, int, double, double, int, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram3D(String, int, double, double, int, double, double, int, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram3D(String, String, double[], double[], double[], String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogram3D(String, String, double[], double[], double[]) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createHistogramFactory(ITree, String) - Method in class hep.aida.ref.BatchAnalysisFactory
 
createIllegalArgumentException(String, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.createIllegalArgumentException(Localizable, Object...)
createIllegalArgumentException(Localizable, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Constructs a new IllegalArgumentException with specified formatted detail message.
createIllegalArgumentException(Throwable) - Static method in exception org.apache.commons.math.MathRuntimeException
Constructs a new IllegalArgumentException with specified nested Throwable root cause.
createIllegalStateException(String, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.createIllegalStateException(Localizable, Object...)
createIllegalStateException(Localizable, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Constructs a new IllegalStateException with specified formatted detail message.
createInternalError(Throwable) - Static method in exception org.apache.commons.math.MathRuntimeException
Create an RuntimeException for an internal error.
createInterpBSpline(double[], double[], int) - Static method in class umontreal.iro.lecuyer.functionfit.BSpline
Returns a B-spline curve of degree degree interpolating the (xi, yi) points.
createIOException(Throwable) - Static method in exception org.apache.commons.math.MathRuntimeException
Constructs a new IOException with specified nested Throwable root cause.
createJELFunctionCore(int, String, String, String) - Method in class hep.aida.ref.function.JELBaseModelFunction
 
createLaguerrePolynomial(int) - Static method in class org.apache.commons.math.analysis.polynomials.PolynomialsUtils
Create a Laguerre polynomial.
createLatexPanel() - Method in class jhplot.jadraw.JaLatexText
Creates a new Panel that display a Label with the String specifying this JaLatexText.
createLegendrePolynomial(int) - Static method in class org.apache.commons.math.analysis.polynomials.PolynomialsUtils
Create a Legendre polynomial.
createManagedObjectGenericFactory(String, ITree, String) - Method in class hep.aida.ref.BatchAnalysisFactory
 
createMatrix(int, int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Create a new RealMatrix of the same type as the instance with the supplied row and column dimensions.
createMatrix(int, int) - Method in class org.apache.commons.math.linear.SparseFieldMatrix
Create a new FieldMatrix of the same type as the instance with the supplied row and column dimensions.
createNamedTree(String, String, String) - Method in class hep.aida.ref.tree.TreeFactory
 
createNamedTree(String, String, String, int) - Method in class hep.aida.ref.tree.TreeFactory
 
createNamedTree(String, String, String, int, String) - Method in class hep.aida.ref.tree.TreeFactory
 
createNoSuchElementException(String, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.createNoSuchElementException(Localizable, Object...)
createNoSuchElementException(Localizable, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Constructs a new NoSuchElementException with specified formatted detail message.
createNullPointerException(String, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.createNullPointerException(Localizable, Object...)
createNullPointerException(Localizable, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. in 2.2. Checks for "null" must not be performed in Commons-Math.
createOptionsString(Map) - Static method in class hep.aida.ref.AidaUtils
 
createParseException(int, String, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.createParseException(int, Localizable, Object...)
createParseException(int, Localizable, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Constructs a new ParseException with specified formatted detail message.
createPlotterFactory() - Method in class hep.aida.ref.AnalysisFactory
 
createPlotterFactory(String) - Method in class hep.aida.ref.BatchAnalysisFactory
 
createProfile1D(String, String, int, double, double, String) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a IProfile1D.
createProfile1D(String, String, int, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile1D(String, String, int, double, double, double, double, String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile1D(String, String, int, double, double, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile1D(String, int, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile1D(String, int, double, double, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile1D(String, String, double[], String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile1D(String, String, double[]) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile1D(String, String, double[], double, double, String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile1D(String, String, double[], double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile2D(String, String, int, double, double, int, double, double, String) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a IProfile2D.
createProfile2D(String, String, int, double, double, int, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile2D(String, String, int, double, double, int, double, double, double, double, String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile2D(String, String, int, double, double, int, double, double, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile2D(String, int, double, double, int, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile2D(String, int, double, double, int, double, double, double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile2D(String, String, double[], double[], String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile2D(String, String, double[], double[]) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile2D(String, String, double[], double[], double, double, String) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createProfile2D(String, String, double[], double[], double, double) - Method in class hep.aida.ref.histogram.HistogramFactory
 
createRealDiagonalMatrix(double[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns a diagonal matrix with specified elements.
createRealIdentityMatrix(int) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns dimension x dimension identity matrix.
createRealMatrix(int, int) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns a RealMatrix with specified dimensions.
createRealMatrix(double[][]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Returns a RealMatrix whose entries are the the values in the the input array.
createRealVector(double[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a RealVector using the data from the input array.
createRowBigMatrix(double[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0 replaced by MatrixUtils.createRowFieldMatrix(FieldElement[])
createRowBigMatrix(BigDecimal[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0 replaced by MatrixUtils.createRowFieldMatrix(FieldElement[])
createRowBigMatrix(String[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deprecated. since 2.0 replaced by MatrixUtils.createRowFieldMatrix(FieldElement[])
createRowFieldMatrix(T[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a row FieldMatrix using the data from the input array.
createRowRealMatrix(double[]) - Static method in class org.apache.commons.math.linear.MatrixUtils
Creates a row RealMatrix using the data from the input array.
createScan1D(IFitData, IFunction, String, int, double, double) - Method in class hep.aida.ref.fitter.Fitter
 
createTree() - Method in class hep.aida.ref.tree.TreeFactory
Creates a new tree and associates it with a store.
createTree(String) - Method in class hep.aida.ref.tree.TreeFactory
 
createTree(String, String) - Method in class hep.aida.ref.tree.TreeFactory
 
createTree(String, String, String) - Method in class hep.aida.ref.tree.TreeFactory
 
createTree(String, String, int) - Method in class hep.aida.ref.tree.TreeFactory
 
createTree(String, String, int, String) - Method in class hep.aida.ref.tree.TreeFactory
 
createTreeFactory(String) - Method in class hep.aida.ref.BatchAnalysisFactory
 
createTupleColumn(String, Class, Value, Tuple) - Static method in class hep.aida.ref.tuple.Tuple.TupleColumnFactory
 
createTupleColumn(String, Class, Value, String, Tuple) - Static method in class hep.aida.ref.tuple.Tuple.TupleColumnFactory
 
createTupleFactory(ITree, String) - Method in class hep.aida.ref.BatchAnalysisFactory
 
createUnsupportedOperationException(Localizable, Object...) - Static method in exception org.apache.commons.math.MathRuntimeException
Deprecated. in 2.2. Please use MathUnsupportedOperationException instead.
createWithTally(int) - Static method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
This factory method constructs and returns a list of tallies with size instances of Tally.
createWithTally(int) - Static method in class umontreal.iro.lecuyer.stat.list.ListOfTalliesWithCovariance
This factory method constructs and returns a list of tallies with size instances of Tally.
createWithTallyStore(int) - Static method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
This factory method constructs and returns a list of tallies with size instances of TallyStore.
createWithTallyStore(int) - Static method in class umontreal.iro.lecuyer.stat.list.ListOfTalliesWithCovariance
This factory method constructs and returns a list of tallies with size instances of TallyStore.
createX(String, double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createX(String, String, double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createX(String, double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createX(String, String, double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createXY(String, double[], double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createXY(String, String, double[], double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createXY(String, double[], double[], double[], double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createXY(String, String, double[], double[], double[], double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createXYZ(String, double[], double[], double[], double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createXYZ(String, String, double[], double[], double[], double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createXYZ(String, double[], double[], double[], double[], double[], double[], double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createXYZ(String, String, double[], double[], double[], double[], double[], double[], double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createY(String, double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createY(String, double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createY(String, String, double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
createY(String, String, double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
Cronbach - Class in flanagan.analysis
 
Cronbach() - Constructor for class flanagan.analysis.Cronbach
 
cross(Hep3Vector, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Cross product of 2 vectors
cross(Hep3Vector, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
crossover(Chromosome, Chromosome) - Method in interface org.apache.commons.math.genetics.CrossoverPolicy
Perform a crossover operation on the given chromosomes.
crossover(Chromosome, Chromosome) - Method in class org.apache.commons.math.genetics.OnePointCrossover
Performs one point crossover.
CrossoverPolicy - Interface in org.apache.commons.math.genetics
Policy used to create a pair of new chromosomes by performing a crossover operation on a source pair of chromosomes.
crossProduct(Vector3D, Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3D
Compute the cross-product of two vectors.
crossSqDistance(Matrix) - Method in class jhplot.bsom.Matrix
Cross squared Euclidean distance Matrix: Z_{ij} = ||X_i - Y_j||^2
csc(double) - Static method in class flanagan.math.Fmath
 
csch(double) - Static method in class flanagan.math.Fmath
 
CSVReader - Class in jhplot.io.csv
A very simple CSV reader released under a commercial-friendly license.
CSVReader(Reader) - Constructor for class jhplot.io.csv.CSVReader
Constructs CSVReader using a comma for the separator.
CSVReader(String) - Constructor for class jhplot.io.csv.CSVReader
Constructs CSVReader using a comma for the separator.
CSVReader(Reader, char) - Constructor for class jhplot.io.csv.CSVReader
Constructs CSVReader with supplied separator.
CSVReader(String, char) - Constructor for class jhplot.io.csv.CSVReader
Constructs CSVReader with supplied separator.
CSVReader(Reader, char, char) - Constructor for class jhplot.io.csv.CSVReader
Constructs CSVReader with supplied separator and quote char.
CSVReader(String, char, char) - Constructor for class jhplot.io.csv.CSVReader
Constructs CSVReader with supplied separator and quote char.
CSVReader(Reader, char, char, int) - Constructor for class jhplot.io.csv.CSVReader
Constructs CSVReader with supplied separator and quote char.
CSVReader(String, char, char, int) - Constructor for class jhplot.io.csv.CSVReader
Constructs CSVReader with supplied separator and quote char.
CsvToBean - Class in jhplot.io.csv.bean
 
CsvToBean() - Constructor for class jhplot.io.csv.bean.CsvToBean
 
CSVWriter - Class in jhplot.io.csv
A very simple CSV writer released under a commercial-friendly license.
CSVWriter(Writer) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter using a comma for the separator.
CSVWriter(String) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter using a comma for the separator.
CSVWriter(Writer, char) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter with supplied separator.
CSVWriter(String, char) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter with supplied separator.
CSVWriter(Writer, char, char) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter with supplied separator and quote char.
CSVWriter(String, char, char) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter with supplied separator and quote char.
CSVWriter(Writer, char, char, char) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter with supplied separator and quote char.
CSVWriter(Writer, char, char, String) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter with supplied separator and quote char.
CSVWriter(String, char, char, String) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter with supplied separator and quote char.
CSVWriter(Writer, char, char, char, String) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter with supplied separator, quote char, escape char and line ending.
CSVWriter(String, char, char, char, String) - Constructor for class jhplot.io.csv.CSVWriter
Constructs CSVWriter with supplied separator, quote char, escape char and line ending.
cube(DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
2-d OLAP cube operator; Fills all cells of the given vectors into the given histogram.
cube(DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
3-d OLAP cube operator; Fills all cells of the given vectors into the given histogram.
cube(DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
2-d OLAP cube operator; Fills all cells of the given vectors into the given histogram.
cube(DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
3-d OLAP cube operator; Fills all cells of the given vectors into the given histogram.
cube(FloatMatrix1D, FloatMatrix1D, FloatMatrix1D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
2-d OLAP cube operator; Fills all cells of the given vectors into the given histogram.
cube(FloatMatrix1D, FloatMatrix1D, FloatMatrix1D, FloatMatrix1D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
3-d OLAP cube operator; Fills all cells of the given vectors into the given histogram.
Cube - Class in jhplot.v3d
Build a cube
Cube(Model3d, float) - Constructor for class jhplot.v3d.Cube
 
CubicSpline - Class in flanagan.interpolation
 
CubicSpline(double[], double[]) - Constructor for class flanagan.interpolation.CubicSpline
 
CubicSpline(int) - Constructor for class flanagan.interpolation.CubicSpline
 
CubicSplineFast - Class in flanagan.interpolation
 
CubicSplineFast(double[], double[]) - Constructor for class flanagan.interpolation.CubicSplineFast
 
CubicSplineFast(int) - Constructor for class flanagan.interpolation.CubicSplineFast
 
CubicSplineShort - Class in flanagan.interpolation
 
CubicSplineShort(double[], double[]) - Constructor for class flanagan.interpolation.CubicSplineShort
 
CubicSplineShort(int) - Constructor for class flanagan.interpolation.CubicSplineShort
 
cumProduct(double[]) - Static method in class jhplot.math.DoubleArray
Calculates cumulative product of the values in an array.
cumProduct(double[][]) - Static method in class jhplot.math.DoubleArray
Calculates the cumulative product of each column in a matrix.
cumSum(double[]) - Static method in class jhplot.math.DoubleArray
Calculates the cumulative sum of an array.
cumSum(double[][]) - Static method in class jhplot.math.DoubleArray
Calculates the cumulative sum of each column in a matrix.
cumulativePercentage() - Method in class flanagan.analysis.PCA
 
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Beta
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.Binomial
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Cauchy
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.ChiSquared
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.ContinuousDistribution
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.DiscreteDistribution
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Exponential
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.FDistribution
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Gamma
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.Geometric
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.Hypergeometric
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Laplace
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Logistic
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.LogNormal
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.NegativeBinomial
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Normal
The CDF for this distribution.
cumulativeProbability(int) - Method in class jhplot.math.num.pdf.Poisson
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Rayleigh
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.TDistribution
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Uniform
The CDF for this distribution.
cumulativeProbability(double) - Method in class jhplot.math.num.pdf.Weibull
The CDF for this distribution.
cumulativeProbability(double, double) - Method in class org.apache.commons.math.distribution.AbstractDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X ≤ x).
cumulativeProbability(double, double) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X ≤ x).
cumulativeProbability(int, int) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
For a random variable X whose values are distributed according to this distribution, this method returns P(X ≤ x).
cumulativeProbability(double, double) - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
For this distribution, X, this method returns P(X ≤ x).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
For this distribution, X, this method returns P(X < x).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
For this distribution, X, this method returns P(X < x).
cumulativeProbability(double) - Method in interface org.apache.commons.math.distribution.Distribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X ≤ x).
cumulativeProbability(double, double) - Method in interface org.apache.commons.math.distribution.Distribution
For a random variable X whose values are distributed according to this distribution, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
For this distribution, X, this method returns P(X < x).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
For this distribution, X, this method returns P(X < x).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
For this distribution, X, this method returns P(X < x).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
For this distribution, X, this method returns P(X ≤ x).
cumulativeProbability(int) - Method in interface org.apache.commons.math.distribution.IntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X ≤ x).
cumulativeProbability(int, int) - Method in interface org.apache.commons.math.distribution.IntegerDistribution
For this distribution, X, this method returns P(x0 ≤ X ≤ x1).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
For this distribution, X, this method returns P(X < x).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
For this distribution, X, this method returns P(X ≤ x).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
The probability distribution function P(X <= x) for a Poisson distribution.
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.TDistributionImpl
For this distribution, X, this method returns P(X < x).
cumulativeProbability(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
For this distribution, X, this method returns P(X < x).
cumulativeProbability(int) - Method in class org.apache.commons.math.distribution.ZipfDistributionImpl
The probability distribution function P(X <= x) for a Zipf distribution.
cupUStoPintUK(double) - Static method in class flanagan.math.Conv
 
cupUStoPintUK(double) - Static method in class flanagan.math.Fmath
 
curie - Static variable in class cern.clhep.Units
 
currentProcess() - Method in class umontreal.iro.lecuyer.simprocs.ProcessSimulator
Returns the currently active process for this simulator.
cursor() - Method in class hep.aida.ref.tuple.AbstractTuple
 
cursor() - Method in interface hep.aida.ref.tuple.FTuple
 
cursor() - Method in class hep.aida.ref.tuple.FTupleAdapter
 
curtosis() - Method in class flanagan.analysis.Stat
 
curtosis(double[]) - Static method in class flanagan.analysis.Stat
 
curtosis(float[]) - Static method in class flanagan.analysis.Stat
 
curtosis(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
curtosis(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
curtosis(long[]) - Static method in class flanagan.analysis.Stat
 
curtosis(int[]) - Static method in class flanagan.analysis.Stat
 
curtosis_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
curtosis_as_double() - Method in class flanagan.analysis.Stat
 
curtosisExcess() - Method in class flanagan.analysis.Stat
 
curtosisExcess(double[]) - Static method in class flanagan.analysis.Stat
 
curtosisExcess(float[]) - Static method in class flanagan.analysis.Stat
 
curtosisExcess(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
curtosisExcess(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
curtosisExcess(long[]) - Static method in class flanagan.analysis.Stat
 
curtosisExcess(int[]) - Static method in class flanagan.analysis.Stat
 
curtosisExcess_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
curtosisExcess_as_double() - Method in class flanagan.analysis.Stat
 
CurveFitter - Class in org.apache.commons.math.optimization.fitting
Fitter for parametric univariate real functions y = f(x).
CurveFitter(DifferentiableMultivariateVectorialOptimizer) - Constructor for class org.apache.commons.math.optimization.fitting.CurveFitter
Simple constructor.
CustomHistogramDataset - Class in umontreal.iro.lecuyer.charts
A dataset that can be used for creating histograms.
CustomHistogramDataset() - Constructor for class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Creates a new (empty) dataset with a default type of HistogramType.FREQUENCY.
CycleBasedPointSet - Class in umontreal.iro.lecuyer.hups
This abstract class provides the basic structures for storing and manipulating a highly uniform point set defined by a set of cycles.
CycleBasedPointSet() - Constructor for class umontreal.iro.lecuyer.hups.CycleBasedPointSet
 
CycleBasedPointSet.CycleBasedPointSetIterator - Class in umontreal.iro.lecuyer.hups
 
CycleBasedPointSet.CycleBasedPointSetIterator() - Constructor for class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
CycleBasedPointSetBase2 - Class in umontreal.iro.lecuyer.hups
Similar to CycleBasedPointSet, except that the successive values in the cycles are stored as integers in the range {0,..., 2k -1}, where 1 <= k <= 31.
CycleBasedPointSetBase2() - Constructor for class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2
 
CycleBasedPointSetBase2.CycleBasedPointSetBase2Iterator - Class in umontreal.iro.lecuyer.hups
 
CycleBasedPointSetBase2.CycleBasedPointSetBase2Iterator() - Constructor for class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2.CycleBasedPointSetBase2Iterator
 
Cylinder - Class in jhplot.v3d
Build a Cylinder.
Cylinder(Model3d, float, int, float) - Constructor for class jhplot.v3d.Cylinder
 

D

d(long) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as d (0, 1, x).
d(int, long) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as d (fieldwidth, 1, x).
d(int, int, long) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Formats the long integer x into a string like %d in the C printf function.
D_FORMAT - Static variable in class jhplot.jadraw.JaObject
The decimal format used for numbers in LaTeX output.
dasum(DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Returns the sum of absolute values; |x[0]| + |x[1]| + ...
dasum(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dasum(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dasum(DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Returns the sum of absolute values; |x[0]| + |x[1]| + ...
dasum(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dasum(FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Returns the sum of absolute values; |x[0]| + |x[1]| + ...
dasum(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dasum(int, double[], int) - Method in class org.netlib.blas.BLAS
..
dataDescription() - Method in class hep.aida.ref.fitter.fitdata.FitData
 
dataDescription() - Method in class hep.aida.ref.fitter.FitResult
 
DataFile - Class in jhplot.math.io
BSD License
DataFile(File) - Constructor for class jhplot.math.io.DataFile
 
DataHolder - Class in jminhep.cluster
Represents an abstraction for a data holder in many dimensional space.
DataHolder() - Constructor for class jminhep.cluster.DataHolder
Creates a new empty instance of data holder
DataHolder(int) - Constructor for class jminhep.cluster.DataHolder
Creates a new empty instance of data point
DataHolder(String) - Constructor for class jminhep.cluster.DataHolder
Creates a new empty instance of data point
DataHolder(DataPoint, DataPoint, int, int) - Constructor for class jminhep.cluster.DataHolder
Creates data holder with random number Input:
dataIterator() - Method in class hep.aida.ref.fitter.fitdata.FitData
 
DataKeeper - Class in jhpro.stat
A convenient class to keep data with error for an internal representation.
DataKeeper(int) - Constructor for class jhpro.stat.DataKeeper
 
DataKeeper(P1D) - Constructor for class jhpro.stat.DataKeeper
Initialize from a P1D
DataKeeper(H1D) - Constructor for class jhpro.stat.DataKeeper
Initialize from a histogram
DataPoint - Class in hep.aida.ref.histogram
Basic user-level interface class for holding and managing a single set of "measurements".
DataPoint(int) - Constructor for class hep.aida.ref.histogram.DataPoint
 
DataPoint(IDataPoint) - Constructor for class hep.aida.ref.histogram.DataPoint
 
DataPoint(IMeasurement[]) - Constructor for class hep.aida.ref.histogram.DataPoint
 
DataPoint(double[]) - Constructor for class hep.aida.ref.histogram.DataPoint
 
DataPoint(double[], double[]) - Constructor for class hep.aida.ref.histogram.DataPoint
 
DataPoint(double[], double[], double[]) - Constructor for class hep.aida.ref.histogram.DataPoint
 
DataPoint - Class in jminhep.cluster
Represents an abstraction for a data point in many-dimensional space
DataPoint(double[], int) - Constructor for class jminhep.cluster.DataPoint
Creates a new instance of a data point
DataPoint(double[]) - Constructor for class jminhep.cluster.DataPoint
Creates a new instance of a data point
DataPointSet - Class in hep.aida.ref.histogram
Basic user-level interface class for holding and managing a single set of "data points".
DataPointSet(String, String, int) - Constructor for class hep.aida.ref.histogram.DataPointSet
 
DataPointSet(String, String, int, int) - Constructor for class hep.aida.ref.histogram.DataPointSet
 
DataPointSet(String, String, int, String) - Constructor for class hep.aida.ref.histogram.DataPointSet
 
DataPointSet(String, String, int, int, String) - Constructor for class hep.aida.ref.histogram.DataPointSet
 
DataPointSetEvent - Class in hep.aida.ref.event
An event send from a Histogram to AIDAListeners
DataPointSetEvent(IDataPointSet) - Constructor for class hep.aida.ref.event.DataPointSetEvent
 
DataPointSetFactory - Class in hep.aida.ref.histogram
Basic user-level interface for creating a factory of IDataPointSet.
DataPointSetFactory(ITree) - Constructor for class hep.aida.ref.histogram.DataPointSetFactory
Create an IDataPointSetFactory.
DataPointSetFactory() - Constructor for class hep.aida.ref.histogram.DataPointSetFactory
 
DataSource - Class in jhpro.stat
This class serves as input for the Limit.ComputeLimit method.
DataSource() - Constructor for class jhpro.stat.DataSource
Simplest constructor.
DataSource(H1D, H1D, H1D) - Constructor for class jhpro.stat.DataSource
Adds one channel with signal, background and data given as input.
DataSource(P1D, P1D, P1D) - Constructor for class jhpro.stat.DataSource
Adds one channel with signal, background and data given as input.
DataSource(H1D, H1D, H1D, double, double, double, String) - Constructor for class jhpro.stat.DataSource
Another constructor, directly adds one channel with signal, background and data given as input.
DataStatistics - Class in hep.aida.ref.dataset
 
DataStatistics(String[]) - Constructor for class hep.aida.ref.dataset.DataStatistics
Creates a new instance of DataSetStatistics.
DataStatistics(int) - Constructor for class hep.aida.ref.dataset.DataStatistics
Creates a new instance of DataSetStatistics.
dateToJavaMilliS(int, int, int, int, int, int) - Static method in class flanagan.math.Fmath
 
dateToJavaMilliSecondsUK(int, int, int, String, int, int, int, int) - Static method in class flanagan.math.Conv
 
dateToJavaMilliSecondsUK(int, int, int, String, int, int, int, int) - Method in class flanagan.math.TimeAndDate
 
daxpy(double, DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Combined vector scaling; y = y + alpha*x.
daxpy(double, DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Combined matrix scaling; B = B + alpha*A.
daxpy(double, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
daxpy(double, DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
daxpy(double, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
daxpy(double, DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
daxpy(double, DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Combined vector scaling; y = y + alpha*x.
daxpy(double, DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Combined matrix scaling; B = B + alpha*A.
daxpy(double, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
daxpy(double, DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
daxpy(float, FloatMatrix1D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Combined vector scaling; y = y + alpha*x.
daxpy(float, FloatMatrix2D, FloatMatrix2D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Combined matrix scaling; B = B + alpha*A.
daxpy(float, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
daxpy(float, FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
daxpy(int, double, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
DbByteArrayOutputStream - Class in jhplot.io
Extends ByteArrayOutputStream to provide a way of writing the buffer to a DataOutput without re-allocating it.
DbByteArrayOutputStream() - Constructor for class jhplot.io.DbByteArrayOutputStream
 
DbByteArrayOutputStream(int) - Constructor for class jhplot.io.DbByteArrayOutputStream
 
dbdsdc(String, String, int, double[], double[], double[], int, double[], int, double[], int[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dbdsqr(String, int, int, int, int, double[], double[], double[], int, double[], int, double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
DBL_DIG - Static variable in class umontreal.iro.lecuyer.util.Num
Number of decimal digits of precision in a double.
DBL_EPSILON - Static variable in class umontreal.iro.lecuyer.util.Num
Difference between 1.0 and the smallest double greater than 1.0.
DBL_MAX_10_EXP - Static variable in class umontreal.iro.lecuyer.util.Num
Largest int x such that 10x is representable (approximately) as a double.
DBL_MAX_EXP - Static variable in class umontreal.iro.lecuyer.util.Num
Largest int x such that 2x-1 is representable (approximately) as a double.
DBL_MIN - Static variable in class umontreal.iro.lecuyer.util.Num
Smallest normalized positive floating-point double.
DBL_MIN_EXP - Static variable in class umontreal.iro.lecuyer.util.Num
Smallest int x such that 2x-1 is representable (approximately) as a normalised double.
DComplex - Class in cern.jet.math.tdcomplex
Complex arithmetic
DComplexDComplexDComplexFunction - Interface in cern.colt.function.tdcomplex
 
DComplexDComplexFunction - Interface in cern.colt.function.tdcomplex
 
DComplexDComplexProcedure - Interface in cern.colt.function.tdcomplex
 
DComplexDComplexRealFunction - Interface in cern.colt.function.tdcomplex
 
DComplexDComplexRealProcedure - Interface in cern.colt.function.tdcomplex
 
DComplexDComplexRealRealFunction - Interface in cern.colt.function.tdcomplex
 
DComplexFactory1D - Class in cern.colt.matrix.tdcomplex
Factory for convenient construction of 1-d matrices holding complex cells.
DComplexFactory2D - Class in cern.colt.matrix.tdcomplex
Factory for convenient construction of 2-d matrices holding complex cells.
DComplexFactory3D - Class in cern.colt.matrix.tdcomplex
Factory for convenient construction of 3-d matrices holding complex cells.
DComplexFunctions - Class in cern.jet.math.tdcomplex
Complex function objects to be passed to generic methods.
DComplexFunctions() - Constructor for class cern.jet.math.tdcomplex.DComplexFunctions
 
DComplexMatrix1D - Class in cern.colt.matrix.tdcomplex
Abstract base class for 1-d matrices (aka vectors) holding complex elements.
DComplexMatrix1DProcedure - Interface in cern.colt.matrix.tdcomplex
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DComplexMatrix2D - Class in cern.colt.matrix.tdcomplex
Abstract base class for 2-d matrices holding complex elements.
DComplexMatrix2DProcedure - Interface in cern.colt.matrix.tdcomplex
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DComplexMatrix3D - Class in cern.colt.matrix.tdcomplex
Abstract base class for 3-d matrices holding complex elements.
DComplexMult - Class in cern.jet.math.tdcomplex
Only for performance tuning of compute intensive linear algebraic computations.
DComplexPlusMultFirst - Class in cern.jet.math.tdcomplex
Only for performance tuning of compute intensive linear algebraic computations.
DComplexPlusMultSecond - Class in cern.jet.math.tdcomplex
Only for performance tuning of compute intensive linear algebraic computations.
DComplexProcedure - Interface in cern.colt.function.tdcomplex
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
DComplexProperty - Class in cern.colt.matrix.tdcomplex.algo
Tests matrices for equality.
DComplexProperty(double) - Constructor for class cern.colt.matrix.tdcomplex.algo.DComplexProperty
Constructs an instance with a tolerance of Math.abs(newTolerance).
DComplexRealDComplexFunction - Interface in cern.colt.function.tdcomplex
 
DComplexRealFunction - Interface in cern.colt.function.tdcomplex
 
dcopy(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Vector assignment (copying); y = x.
dcopy(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Matrix assignment (copying); B = A.
dcopy(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dcopy(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dcopy(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dcopy(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dcopy(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Vector assignment (copying); y = x.
dcopy(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Matrix assignment (copying); B = A.
dcopy(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dcopy(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dcopy(FloatMatrix1D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Vector assignment (copying); y = x.
dcopy(FloatMatrix2D, FloatMatrix2D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Matrix assignment (copying); B = A.
dcopy(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dcopy(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dcopy(int, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dct(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Computes the discrete cosine transform (DCT-II) of this matrix.
dct(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Computes the discrete cosine transform (DCT-II) of this matrix.
dct2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the 2D discrete cosine transform (DCT-II) of this matrix.
dct2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the 2D discrete cosine transform (DCT-II) of this matrix.
dct2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the 2D discrete cosine transform (DCT-II) of this matrix.
dct2(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the 2D discrete cosine transform (DCT-II) of this matrix.
dct2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the 2D discrete cosine transform (DCT-II) of this matrix.
dct2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the 2D discrete cosine transform (DCT-II) of this matrix.
dct2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the 2D discrete cosine transform (DCT-II) of this matrix.
dct2(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the 2D discrete cosine transform (DCT-II) of this matrix.
dct2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 2D discrete cosine transform (DCT-II) of each slice of this matrix.
dct2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 2D discrete cosine transform (DCT-II) of each slice of this matrix.
dct2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 2D discrete cosine transform (DCT-II) of each slice of this matrix.
dct2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 2D discrete cosine transform (DCT-II) of each slice of this matrix.
dct2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 2D discrete cosine transform (DCT-II) of each slice of this matrix.
dct2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 2D discrete cosine transform (DCT-II) of each slice of this matrix.
dct3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 3D discrete cosine transform (DCT-II) of this matrix.
dct3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 3D discrete cosine transform (DCT-II) of this matrix.
dct3(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 3D discrete cosine transform (DCT-II) of this matrix.
dct3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 3D discrete cosine transform (DCT-II) of this matrix.
dct3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 3D discrete cosine transform (DCT-II) of this matrix.
dct3(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 3D discrete cosine transform (DCT-II) of this matrix.
dctColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the discrete cosine transform (DCT-II) of each column of this matrix.
dctColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the discrete cosine transform (DCT-II) of each column of this matrix.
dctColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the discrete cosine transform (DCT-II) of each column of this matrix.
dctColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the discrete cosine transform (DCT-II) of each column of this matrix.
dctColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the discrete cosine transform (DCT-II) of each column of this matrix.
dctColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the discrete cosine transform (DCT-II) of each column of this matrix.
dctColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the discrete cosine transform (DCT-II) of each column of this matrix.
dctColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the discrete cosine transform (DCT-II) of each column of this matrix.
dctRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the discrete cosine transform (DCT-II) of each row of this matrix.
dctRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the discrete cosine transform (DCT-II) of each row of this matrix.
dctRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the discrete cosine transform (DCT-II) of each row of this matrix.
dctRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the discrete cosine transform (DCT-II) of each row of this matrix.
dctRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the discrete cosine transform (DCT-II) of each row of this matrix.
dctRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the discrete cosine transform (DCT-II) of each row of this matrix.
dctRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the discrete cosine transform (DCT-II) of each row of this matrix.
dctRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the discrete cosine transform (DCT-II) of each row of this matrix.
ddisna(String, int, int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
ddot(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
ddot(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
ddot(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
ddot(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
ddot(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
ddot(FloatMatrix1D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
ddot(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
ddot(int, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
DEAD - Static variable in class umontreal.iro.lecuyer.simprocs.SimProcess
The process has terminated its execution.
dec - Static variable in class cern.jet.math.IntFunctions
Function that returns a--.
dec - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a--.
dec - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a--.
DECIMAL - Static variable in class cern.colt.matrix.AbstractFormatter
The alignment string aligning the cells of a column to the decimal point.
DECIMAL - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The alignment string aligning the cells of a column to the decimal point.
decode(List<T>) - Method in interface org.apache.commons.math.genetics.PermutationChromosome
Permutes the sequence of objects of type T according to the permutation this chromosome represents.
decode(List<T>) - Method in class org.apache.commons.math.genetics.RandomKey
Permutes the sequence of objects of type T according to the permutation this chromosome represents.
decompose(DoubleMatrix2D[][], DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
decompose(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Decomposes matrix A into L and U (in-place).
decompose(DoubleMatrix2D, int) - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Decomposes the banded and square matrix A into L and U (in-place).
decompose(ObjectMatrix2D[][], ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
decompose(DComplexMatrix2D[][], DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
decompose(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Decomposes matrix A into L and U (in-place).
decompose(DoubleMatrix2D, int) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Decomposes the banded and square matrix A into L and U (in-place).
decompose(DoubleMatrix2D[][], DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
decompose(FComplexMatrix2D[][], FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
decompose(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Decomposes matrix A into L and U (in-place).
decompose(FloatMatrix2D, int) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Decomposes the banded and square matrix A into L and U (in-place).
decompose(FloatMatrix2D[][], FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
decompose(IntMatrix2D[][], IntMatrix2D) - Method in class cern.colt.matrix.tint.IntFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
decompose(LongMatrix2D[][], LongMatrix2D) - Method in class cern.colt.matrix.tlong.LongFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
decompose(ObjectMatrix2D[][], ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
Splits a block matrix into its constituent blocks; Copies blocks of a matrix into the given parts.
DecompositionSolver - Interface in org.apache.commons.math.linear
Interface handling decomposition algorithms that can solve A × X = B.
decompPCA(double[][]) - Static method in class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Computes the decomposition sigma = Σ = VΛVt.
decompPCA(DoubleMatrix2D) - Static method in class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Computes the decomposition sigma = Σ = VΛVt.
decompPCA(double[][]) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCA
 
decPrec - Variable in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Deprecated. 
decPrec - Variable in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistribution2Dim
Defines the target number of decimals of accuracy when approximating a distribution function, but there is no guarantee that this target is always attained.
DEFAULT - Static variable in class cern.colt.matrix.linalg.Algebra
A default Algebra object; has Property.DEFAULT attached for tolerance.
DEFAULT - Static variable in class cern.colt.matrix.linalg.Property
The default Property object; currently has tolerance()==1.0E-9.
DEFAULT - Static variable in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
The default Property object; currently has tolerance()==1.0E-9.
DEFAULT - Static variable in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
A default Algebra object; has DoubleProperty.DEFAULT attached for tolerance.
DEFAULT - Static variable in class cern.colt.matrix.tdouble.algo.DoubleProperty
The default Property object; currently has tolerance()==1.0E-9.
DEFAULT - Static variable in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
A default Algebra object; has DoubleProperty.DEFAULT attached for tolerance.
DEFAULT - Static variable in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
The default Property object; currently has tolerance()==1.0E-5.
DEFAULT - Static variable in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
A default Algebra object; has FloatProperty.DEFAULT attached for tolerance.
DEFAULT - Static variable in class cern.colt.matrix.tfloat.algo.FloatProperty
The default Property object; currently has tolerance()==1.0E-5.
DEFAULT - Static variable in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
A default Algebra object; has FloatProperty.DEFAULT attached for tolerance.
DEFAULT - Static variable in class cern.colt.matrix.tint.algo.IntProperty
The default Property object;.
DEFAULT - Static variable in class cern.colt.matrix.tlong.algo.LongProperty
The default Property object;.
DEFAULT_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math.analysis.solvers.BrentSolver
Default absolute accuracy
DEFAULT_ABSOLUTE_POSITIVITY_THRESHOLD - Static variable in class org.apache.commons.math.linear.CholeskyDecompositionImpl
Default threshold below which diagonal elements are considered null and matrix not positive definite.
DEFAULT_ACCURACY - Static variable in class org.apache.commons.math.analysis.interpolation.LoessInterpolator
Default value for accuracy.
DEFAULT_BANDWIDTH - Static variable in class org.apache.commons.math.analysis.interpolation.LoessInterpolator
Default value of the bandwidth parameter.
DEFAULT_BRIGHTNESS_EXPONENT - Static variable in class org.apache.commons.math.analysis.interpolation.MicrosphereInterpolator
Default exponent used the weights calculation.
DEFAULT_COLUMN_SEPARATOR - Static variable in class cern.colt.matrix.AbstractFormatter
The default string separating any two columns from another; currently " ".
DEFAULT_COLUMN_SEPARATOR - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The default string separating any two columns from another; currently " ".
DEFAULT_EPSILON - Static variable in class org.apache.commons.math.distribution.PoissonDistributionImpl
Default convergence criterion.
DEFAULT_ESCAPE_CHARACTER - Static variable in class jhplot.io.csv.CSVWriter
The character used for escaping quotes.
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math.distribution.BetaDistributionImpl
Default inverse cumulative probability accuracy
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math.distribution.CauchyDistributionImpl
Default inverse cumulative probability accuracy
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Default inverse cumulative probability accuracy
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Default inverse cumulative probability accuracy
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math.distribution.FDistributionImpl
Default inverse cumulative probability accuracy
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math.distribution.GammaDistributionImpl
Default inverse cumulative probability accuracy
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math.distribution.NormalDistributionImpl
Default inverse cumulative probability accuracy
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math.distribution.TDistributionImpl
Default inverse cumulative probability accuracy
DEFAULT_INVERSE_ABSOLUTE_ACCURACY - Static variable in class org.apache.commons.math.distribution.WeibullDistributionImpl
Default inverse cumulative probability accuracy
DEFAULT_LINE_END - Static variable in class jhplot.io.csv.CSVWriter
Default line terminator uses platform encoding.
DEFAULT_LS_ABSOLUTE_TOLERANCE - Static variable in class org.apache.commons.math.optimization.direct.PowellOptimizer
Default absolute tolerance for line search (1.0E-11).
DEFAULT_LS_RELATIVE_TOLERANCE - Static variable in class org.apache.commons.math.optimization.direct.PowellOptimizer
Default relative tolerance for line search (1.0E-7).
DEFAULT_MAX_COST_EVALUATIONS - Static variable in class org.apache.commons.math.estimation.AbstractEstimator
Deprecated. Default maximal number of cost evaluations allowed.
DEFAULT_MAX_ITERATIONS - Static variable in class org.apache.commons.math.distribution.PoissonDistributionImpl
Default maximum number of iterations for cumulative probability calculations.
DEFAULT_MAX_ITERATIONS - Static variable in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Default maximal number of iterations allowed.
DEFAULT_MAX_ITERATIONS - Static variable in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Default maximal number of iterations allowed.
DEFAULT_MAX_ITERATIONS - Static variable in class org.apache.commons.math.optimization.linear.AbstractLinearOptimizer
Default maximal number of iterations allowed.
DEFAULT_MAXIMUM_ITERATIONS - Static variable in class org.apache.commons.math.analysis.solvers.BrentSolver
Default maximum number of iterations
DEFAULT_MICROSPHERE_ELEMENTS - Static variable in class org.apache.commons.math.analysis.interpolation.MicrosphereInterpolator
Default number of surface elements that composes the microsphere.
DEFAULT_MIN_COLUMN_WIDTH - Static variable in class cern.colt.matrix.AbstractFormatter
The default minimum number of characters a column may have; currently 1.
DEFAULT_MIN_COLUMN_WIDTH - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The default minimum number of characters a column may have; currently 1.
DEFAULT_NAN_STRATEGY - Static variable in class org.apache.commons.math.stat.ranking.NaturalRanking
default NaN strategy
DEFAULT_QUOTE_CHARACTER - Static variable in class jhplot.io.csv.CSVReader
The default quote character to use if none is supplied to the constructor.
DEFAULT_QUOTE_CHARACTER - Static variable in class jhplot.io.csv.CSVWriter
The default quote character to use if none is supplied to the constructor.
DEFAULT_RELATIVE_SYMMETRY_THRESHOLD - Static variable in class org.apache.commons.math.linear.CholeskyDecompositionImpl
Default threshold above which off-diagonal elements are considered too different and matrix not symmetric.
DEFAULT_ROBUSTNESS_ITERS - Static variable in class org.apache.commons.math.analysis.interpolation.LoessInterpolator
Default value of the number of robustness iterations.
DEFAULT_ROW_SEPARATOR - Static variable in class cern.colt.matrix.AbstractFormatter
The default string separating any two rows from another; currently "\n".
DEFAULT_ROW_SEPARATOR - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The default string separating any two rows from another; currently "\n".
DEFAULT_SEED - Static variable in class cern.jet.random.engine.DRand
 
DEFAULT_SEED - Static variable in class cern.jet.random.engine.MersenneTwister
 
DEFAULT_SEED - Static variable in class cern.jet.random.tdouble.engine.DoubleMersenneTwister
 
DEFAULT_SEED - Static variable in class cern.jet.random.tdouble.engine.DRand
 
DEFAULT_SEED - Static variable in class cern.jet.random.tfloat.engine.FloatMersenneTwister
 
DEFAULT_SEED - Static variable in class cern.jet.random.tfloat.engine.FRand
 
DEFAULT_SEPARATOR - Static variable in class jhplot.io.csv.CSVReader
The default separator to use if none is supplied to the constructor.
DEFAULT_SEPARATOR - Static variable in class jhplot.io.csv.CSVWriter
The default separator to use if none is supplied to the constructor.
DEFAULT_SKIP_LINES - Static variable in class jhplot.io.csv.CSVReader
The default line to start reading.
DEFAULT_SLICE_SEPARATOR - Static variable in class cern.colt.matrix.AbstractFormatter
The default string separating any two slices from another; currently "\n\n".
DEFAULT_SLICE_SEPARATOR - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The default string separating any two slices from another; currently "\n\n".
DEFAULT_TIES_STRATEGY - Static variable in class org.apache.commons.math.stat.ranking.NaturalRanking
default ties strategy
DEFAULT_ZERO_TOLERANCE - Static variable in class org.apache.commons.math.linear.OpenMapRealVector
Default Tolerance for having a value considered zero.
DefaultBinner - Class in hep.aida.ref.dataset.binner
The default implementation of a Binner.
DefaultBinner(int[], String) - Constructor for class hep.aida.ref.dataset.binner.DefaultBinner
Creates a new instance of Binner.
DefaultDoubleIterationMonitor - Class in cern.colt.matrix.tdouble.algo.solver
Default iteration monitor.
DefaultDoubleIterationMonitor(int, double, double, double) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DefaultDoubleIterationMonitor
Constructor for DefaultIterationMonitor
DefaultDoubleIterationMonitor() - Constructor for class cern.colt.matrix.tdouble.algo.solver.DefaultDoubleIterationMonitor
Constructor for DefaultIterationMonitor.
DefaultFieldMatrixChangingVisitor<T extends FieldElement<T>> - Class in org.apache.commons.math.linear
Default implementation of the FieldMatrixChangingVisitor interface.
DefaultFieldMatrixChangingVisitor(T) - Constructor for class org.apache.commons.math.linear.DefaultFieldMatrixChangingVisitor
Build a new instance.
DefaultFieldMatrixPreservingVisitor<T extends FieldElement<T>> - Class in org.apache.commons.math.linear
Default implementation of the FieldMatrixPreservingVisitor interface.
DefaultFieldMatrixPreservingVisitor(T) - Constructor for class org.apache.commons.math.linear.DefaultFieldMatrixPreservingVisitor
Build a new instance.
DefaultFloatIterationMonitor - Class in cern.colt.matrix.tfloat.algo.solver
Default iteration monitor.
DefaultFloatIterationMonitor(int, float, float, float) - Constructor for class cern.colt.matrix.tfloat.algo.solver.DefaultFloatIterationMonitor
Constructor for DefaultIterationMonitor
DefaultFloatIterationMonitor() - Constructor for class cern.colt.matrix.tfloat.algo.solver.DefaultFloatIterationMonitor
Constructor for DefaultIterationMonitor.
defaultFunctions() - Method in class hep.aida.ref.function.FunctionCatalog
 
defaultNames - Static variable in class hep.aida.ref.function.FunctionCatalog
 
DefaultRealMatrixChangingVisitor - Class in org.apache.commons.math.linear
Default implementation of the RealMatrixChangingVisitor interface.
DefaultRealMatrixChangingVisitor() - Constructor for class org.apache.commons.math.linear.DefaultRealMatrixChangingVisitor
 
DefaultRealMatrixPreservingVisitor - Class in org.apache.commons.math.linear
Default implementation of the RealMatrixPreservingVisitor interface.
DefaultRealMatrixPreservingVisitor() - Constructor for class org.apache.commons.math.linear.DefaultRealMatrixPreservingVisitor
 
defaultSimulator - Static variable in class umontreal.iro.lecuyer.simevents.Simulator
Represents the default simulator being used by the class Sim, and the no-argument constructor of Event.
DefaultTransformer - Class in org.apache.commons.math.util
A Default NumberTransformer for java.lang.Numbers and Numeric Strings.
DefaultTransformer() - Constructor for class org.apache.commons.math.util.DefaultTransformer
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BooleanTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ByteTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.CharTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.DoubleTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.FloatTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.IntTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ITupleTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.LongTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ObjectTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ShortTupleColumn
 
defaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.StringTupleColumn
 
defaultValue(Value) - Method in interface hep.aida.ref.tuple.FTupleColumn
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnBoolean
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnBoolean
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnByte
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnByte
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnChar
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnChar
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnDouble
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnDouble
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFloat
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFloat
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnInt
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnInt
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnLong
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnLong
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnObject
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnObject
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnShort
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnShort
 
defaultValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnString
 
defaultValue() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnString
 
defineHistogram(String, int, double, double) - Method in class jhplot.HChart
Define a histogram to fill histogram chart
deg - Static variable in class cern.clhep.Units
 
degree - Static variable in class cern.clhep.Units
 
degree() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Returns the degree of the polynomial
degree() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns the degree of the polynomial.
degree() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionNewtonForm
Returns the degree of the polynomial.
degToRad(double) - Static method in class flanagan.math.Conv
 
degToRad(double) - Static method in class flanagan.math.Fmath
 
delay(SimProcess, double) - Method in class umontreal.iro.lecuyer.simprocs.DSOLProcessSimulator
 
delay(SimProcess, double) - Method in class umontreal.iro.lecuyer.simprocs.ProcessSimulator
Suspends the execution of process and schedules it to resume its execution in delay units of simulation time.
delay(double) - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Suspends the execution of the currently executing process and schedules it to resume its execution in delay units of simulation time.
delay(SimProcess, double) - Method in class umontreal.iro.lecuyer.simprocs.ThreadProcessSimulator
 
DELAYED - Static variable in class umontreal.iro.lecuyer.simprocs.SimProcess
The process is not executing but has an event in the event list to reactivate it later on.
delete(boolean) - Method in class cern.colt.list.AbstractBooleanList
Deletes the first element from the receiver that is identical to the specified element.
delete(byte) - Method in class cern.colt.list.AbstractByteList
Deletes the first element from the receiver that is identical to the specified element.
delete(char) - Method in class cern.colt.list.AbstractCharList
Deletes the first element from the receiver that is identical to the specified element.
delete(double) - Method in class cern.colt.list.AbstractDoubleList
Deletes the first element from the receiver that is identical to the specified element.
delete(float) - Method in class cern.colt.list.AbstractFloatList
Deletes the first element from the receiver that is identical to the specified element.
delete(int) - Method in class cern.colt.list.AbstractIntList
Deletes the first element from the receiver that is identical to the specified element.
delete(long) - Method in class cern.colt.list.AbstractLongList
Deletes the first element from the receiver that is identical to the specified element.
delete(short) - Method in class cern.colt.list.AbstractShortList
Deletes the first element from the receiver that is identical to the specified element.
delete(Object, boolean) - Method in class cern.colt.list.ObjectArrayList
Deletes the first element from the receiver that matches the specified element.
delete(boolean) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Deletes the first element from the receiver that is identical to the specified element.
delete(byte) - Method in class cern.colt.list.tbyte.AbstractByteList
Deletes the first element from the receiver that is identical to the specified element.
delete(char) - Method in class cern.colt.list.tchar.AbstractCharList
Deletes the first element from the receiver that is identical to the specified element.
delete(double) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Deletes the first element from the receiver that is identical to the specified element.
delete(float) - Method in class cern.colt.list.tfloat.AbstractFloatList
Deletes the first element from the receiver that is identical to the specified element.
delete(int) - Method in class cern.colt.list.tint.AbstractIntList
Deletes the first element from the receiver that is identical to the specified element.
delete(long) - Method in class cern.colt.list.tlong.AbstractLongList
Deletes the first element from the receiver that is identical to the specified element.
delete(Object, boolean) - Method in class cern.colt.list.tobject.ObjectArrayList
Deletes the first element from the receiver that matches the specified element.
delete(short) - Method in class cern.colt.list.tshort.AbstractShortList
Deletes the first element from the receiver that is identical to the specified element.
delete(double[], int...) - Static method in class jhplot.math.DoubleArray
Delete a list of elements from an array.
delete(int[], int...) - Static method in class jhplot.math.IntegerArray
 
deleteColumns(double[][], int...) - Static method in class jhplot.math.DoubleArray
Deletes a list of columns from a matrix.
deleteColumns(int[][], int...) - Static method in class jhplot.math.IntegerArray
 
deleteColumnsRange(double[][], int, int) - Static method in class jhplot.math.DoubleArray
Deletes a range of columns from a matrix.
deleteColumnsRange(int[][], int, int) - Static method in class jhplot.math.IntegerArray
 
deleteDir(File) - Static method in class jhplot.v3d.Util
Deletes all files and subdirectories under dir.
deletedItemsIndices() - Method in class flanagan.analysis.Scores
 
deletedItemsNames() - Method in class flanagan.analysis.Scores
 
deletedPersonsIndices() - Method in class flanagan.analysis.Scores
 
deleteItem(String) - Method in class flanagan.analysis.Scores
 
deleteItem(int) - Method in class flanagan.analysis.Scores
 
deleteObserver(Observer) - Method in class hep.aida.ref.event.ObserverAdapter
 
deleteObservers() - Method in class hep.aida.ref.event.ObserverAdapter
 
deleteRange(double[], int, int) - Static method in class jhplot.math.DoubleArray
Delete a range of elements from an array.
deleteRange(int[], int, int) - Static method in class jhplot.math.IntegerArray
 
deleteRecord(String) - Method in class jhplot.io.BaseRecordsFile
Deletes a record.
deleteRows(double[][], int...) - Static method in class jhplot.math.DoubleArray
Deletes a list of rows from a matrix.
deleteRows(int[][], int...) - Static method in class jhplot.math.IntegerArray
 
deleteRowsRange(double[][], int, int) - Static method in class jhplot.math.DoubleArray
Deletes a range of rows from a matrix.
deleteRowsRange(int[][], int, int) - Static method in class jhplot.math.IntegerArray
 
delta() - Method in class flanagan.analysis.ProbabilityPlot
 
demo1() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo1() - Static method in class cern.colt.matrix.doublealgo.Statistic
Demonstrates usage of this class.
demo1() - Method in class cern.colt.matrix.DoubleFactory2D
Demonstrates usage of this class.
demo1() - Static method in class cern.colt.matrix.impl.AbstractFormatter
Demonstrates how to use this class.
demo1() - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Demonstrates usage of this class.
demo1() - Static method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Demonstrates how to use this class.
demo1() - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Demonstrates usage of this class.
demo1() - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Demonstrates usage of this class.
demo1() - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Demonstrates usage of this class.
demo1() - Static method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Demonstrates how to use this class.
demo1() - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Demonstrates usage of this class.
demo1() - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Demonstrates usage of this class.
demo1() - Method in class cern.colt.matrix.tint.IntFactory2D
Demonstrates usage of this class.
demo1() - Method in class cern.colt.matrix.tlong.LongFactory2D
Demonstrates usage of this class.
demo1() - Static method in class cern.jet.math.Functions
Demonstrates usage of this class.
demo1() - Static method in class cern.jet.math.tdouble.DoubleFunctions
Demonstrates usage of this class.
demo1() - Static method in class cern.jet.math.tfloat.FloatFunctions
Demonstrates usage of this class.
demo1() - Static method in class cern.jet.random.Benchmark
Prints the first size random numbers generated by the distribution.
demo2() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo2(int, int, boolean) - Static method in class cern.colt.matrix.doublealgo.Statistic
Demonstrates usage of this class.
demo2() - Method in class cern.colt.matrix.DoubleFactory2D
Demonstrates usage of this class.
demo2() - Static method in class cern.colt.matrix.impl.AbstractFormatter
Demonstrates how to use this class.
demo2() - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Demonstrates usage of this class.
demo2() - Static method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Demonstrates how to use this class.
demo2(int, int, boolean) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Demonstrates usage of this class.
demo2() - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Demonstrates usage of this class.
demo2() - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Demonstrates usage of this class.
demo2() - Static method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Demonstrates how to use this class.
demo2(int, int, boolean) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Demonstrates usage of this class.
demo2() - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Demonstrates usage of this class.
demo2() - Method in class cern.colt.matrix.tint.IntFactory2D
Demonstrates usage of this class.
demo2() - Method in class cern.colt.matrix.tlong.LongFactory2D
Demonstrates usage of this class.
demo2(int) - Static method in class cern.jet.math.Functions
Benchmarks and demonstrates usage of trivial and complex functions.
demo2(int) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Benchmarks and demonstrates usage of trivial and complex functions.
demo2(int) - Static method in class cern.jet.math.tfloat.FloatFunctions
Benchmarks and demonstrates usage of trivial and complex functions.
demo3(int, double) - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo3(Statistic.VectorVectorFunction) - Static method in class cern.colt.matrix.doublealgo.Statistic
Demonstrates usage of this class.
demo3(int, Object) - Static method in class cern.colt.matrix.impl.AbstractFormatter
Demonstrates how to use this class.
demo3(int, double) - Static method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Demonstrates how to use this class.
demo3(DoubleStatistic.VectorVectorFunction) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Demonstrates usage of this class.
demo3(int, float) - Static method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Demonstrates how to use this class.
demo3(FloatStatistic.VectorVectorFunction) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Demonstrates usage of this class.
demo4() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo4() - Static method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Demonstrates how to use this class.
demo4() - Static method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Demonstrates how to use this class.
demo5() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo5() - Static method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Demonstrates how to use this class.
demo5() - Static method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Demonstrates how to use this class.
demo6() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo6() - Static method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Demonstrates how to use this class.
demo6() - Static method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Demonstrates how to use this class.
demo7() - Static method in class cern.colt.matrix.doublealgo.Formatter
Demonstrates how to use this class.
demo7() - Static method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Demonstrates how to use this class.
demo7() - Static method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Demonstrates how to use this class.
dense - Static variable in class cern.colt.matrix.DoubleFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.DoubleFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.DoubleFactory3D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.ObjectFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.ObjectFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.ObjectFactory3D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tdcomplex.DComplexFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tdcomplex.DComplexFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tdcomplex.DComplexFactory3D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tdouble.DoubleFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tdouble.DoubleFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tdouble.DoubleFactory3D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tfcomplex.FComplexFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tfcomplex.FComplexFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tfcomplex.FComplexFactory3D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tfloat.FloatFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tfloat.FloatFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tfloat.FloatFactory3D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tint.IntFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tint.IntFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tint.IntFactory3D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tlong.LongFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tlong.LongFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tlong.LongFactory3D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tobject.ObjectFactory1D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tobject.ObjectFactory2D
A factory producing dense matrices.
dense - Static variable in class cern.colt.matrix.tobject.ObjectFactory3D
A factory producing dense matrices.
DenseColumnDComplexMatrix2D - Class in cern.colt.matrix.tdcomplex.impl
Dense 2-d matrix holding complex elements.
DenseColumnDComplexMatrix2D(double[][]) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
Constructs a matrix with a copy of the given values.
DenseColumnDComplexMatrix2D(DoubleMatrix2D) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
Constructs a complex matrix with the same size as realPart matrix and fills the real part of this matrix with elements of realPart.
DenseColumnDComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseColumnDComplexMatrix2D(int, int, double[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
Constructs a matrix with the given parameters.
DenseColumnDoubleMatrix2D - Class in cern.colt.matrix.tdouble.impl
Dense 2-d matrix holding double elements.
DenseColumnDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Constructs a matrix with a copy of the given values.
DenseColumnDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseColumnDoubleMatrix2D(int, int, double[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Constructs a matrix with the given parameters.
DenseColumnDoubleMatrix2D(MatrixVectorReader) - Constructor for class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Constructs a matrix from MatrixVectorReader.
DenseColumnFComplexMatrix2D - Class in cern.colt.matrix.tfcomplex.impl
Dense 2-d matrix holding complex elements.
DenseColumnFComplexMatrix2D(float[][]) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
Constructs a matrix with a copy of the given values.
DenseColumnFComplexMatrix2D(FloatMatrix2D) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
Constructs a complex matrix with the same size as realPart matrix and fills the real part of this matrix with elements of realPart.
DenseColumnFComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseColumnFComplexMatrix2D(int, int, float[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
Constructs a matrix with the given parameters.
DenseColumnFloatMatrix2D - Class in cern.colt.matrix.tfloat.impl
Dense 2-d matrix holding float elements.
DenseColumnFloatMatrix2D(float[][]) - Constructor for class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Constructs a matrix with a copy of the given values.
DenseColumnFloatMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseColumnFloatMatrix2D(int, int, float[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Constructs a matrix with the given parameters.
DenseColumnFloatMatrix2D(MatrixVectorReader) - Constructor for class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Constructs a matrix from MatrixVectorReader.
DenseColumnIntMatrix2D - Class in cern.colt.matrix.tint.impl
Dense 2-d matrix holding int elements.
DenseColumnIntMatrix2D(int[][]) - Constructor for class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
Constructs a matrix with a copy of the given values.
DenseColumnIntMatrix2D(int, int) - Constructor for class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseColumnIntMatrix2D(int, int, int[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
Constructs a matrix with the given parameters.
DenseColumnIntMatrix2D(MatrixVectorReader) - Constructor for class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
Constructs a matrix from MatrixVectorReader.
DenseColumnLongMatrix2D - Class in cern.colt.matrix.tlong.impl
Dense 2-d matrix holding long elements.
DenseColumnLongMatrix2D(long[][]) - Constructor for class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
Constructs a matrix with a copy of the given values.
DenseColumnLongMatrix2D(int, int) - Constructor for class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseColumnLongMatrix2D(int, int, long[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
Constructs a matrix with the given parameters.
DenseColumnLongMatrix2D(MatrixVectorReader) - Constructor for class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
Constructs a matrix from MatrixVectorReader.
DenseColumnObjectMatrix2D - Class in cern.colt.matrix.tobject.impl
Dense 2-d matrix holding Object elements.
DenseColumnObjectMatrix2D(Object[][]) - Constructor for class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
Constructs a matrix with a copy of the given values.
DenseColumnObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseColumnObjectMatrix2D(int, int, Object[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
Constructs a matrix with the given parameters.
DenseDComplexMatrix1D - Class in cern.colt.matrix.tdcomplex.impl
Dense 1-d matrix (aka vector) holding complex elements.
DenseDComplexMatrix1D(double[]) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
Constructs a matrix with a copy of the given values.
DenseDComplexMatrix1D(DoubleMatrix1D) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
Constructs a complex matrix with the same size as realPart matrix and fills the real part of this matrix with elements of realPart.
DenseDComplexMatrix1D(int) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
Constructs a matrix with a given number of cells.
DenseDComplexMatrix1D(int, double[], int, int, boolean) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
Constructs a matrix with the given parameters.
DenseDComplexMatrix2D - Class in cern.colt.matrix.tdcomplex.impl
Dense 2-d matrix holding complex elements.
DenseDComplexMatrix2D(double[][]) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
Constructs a matrix with a copy of the given values.
DenseDComplexMatrix2D(DoubleMatrix2D) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
Constructs a complex matrix with the same size as realPart matrix and fills the real part of this matrix with elements of realPart.
DenseDComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseDComplexMatrix2D(int, int, double[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
Constructs a matrix with the given parameters.
DenseDComplexMatrix3D - Class in cern.colt.matrix.tdcomplex.impl
Dense 3-d matrix holding complex elements.
DenseDComplexMatrix3D(double[][][]) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
Constructs a matrix with a copy of the given values.
DenseDComplexMatrix3D(DoubleMatrix3D) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
Constructs a matrix with the same size as realPart matrix and fills the real part of this matrix with elements of realPart.
DenseDComplexMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
DenseDComplexMatrix3D(int, int, int, double[], int, int, int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
Constructs a matrix with the given parameters.
DenseDoubleAlgebra - Class in cern.colt.matrix.tdouble.algo
Linear algebraic matrix operations operating on dense matrices.
DenseDoubleAlgebra() - Constructor for class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Constructs a new instance with an equality tolerance given by Property.DEFAULT.tolerance().
DenseDoubleAlgebra(double) - Constructor for class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Constructs a new instance with the given equality tolerance.
DenseDoubleCholeskyDecomposition - Class in cern.colt.matrix.tdouble.algo.decomposition
For a symmetric, positive definite matrix A, the Cholesky decomposition is a lower triangular matrix L so that A = L*L'; If the matrix is not symmetric positive definite, the IllegalArgumentException is thrown.
DenseDoubleCholeskyDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleCholeskyDecomposition
Constructs and returns a new Cholesky decomposition object for a symmetric and positive definite matrix; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
DenseDoubleEigenvalueDecomposition - Class in cern.colt.matrix.tdouble.algo.decomposition
Eigenvalues and eigenvectors of a real matrix A.
DenseDoubleEigenvalueDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleEigenvalueDecomposition
Constructs and returns a new eigenvalue decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
DenseDoubleLUDecomposition - Class in cern.colt.matrix.tdouble.algo.decomposition
For an m x n matrix A with m >= n, the LU decomposition is an m x n unit lower triangular matrix L, an n x n upper triangular matrix U, and a permutation vector piv of length m so that A(piv,:) = L*U; If m < n, then L is m x m and U is m x n.
DenseDoubleLUDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecomposition
Constructs and returns a new LU Decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
DenseDoubleLUDecompositionQuick - Class in cern.colt.matrix.tdouble.algo.decomposition
A low level version of DenseDoubleLUDecomposition, avoiding unnecessary memory allocation and copying.
DenseDoubleLUDecompositionQuick() - Constructor for class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Constructs and returns a new LU Decomposition object with default tolerance 1.0E-9 for singularity detection.
DenseDoubleLUDecompositionQuick(double) - Constructor for class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Constructs and returns a new LU Decomposition object which uses the given tolerance for singularity detection;
DenseDoubleMatrix1D - Class in cern.colt.matrix.impl
Dense 1-d matrix (aka vector) holding double elements.
DenseDoubleMatrix1D(double[]) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix1D
Constructs a matrix with a copy of the given values.
DenseDoubleMatrix1D(int) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix1D
Constructs a matrix with a given number of cells.
DenseDoubleMatrix1D - Class in cern.colt.matrix.tdouble.impl
Dense 1-d matrix (aka vector) holding double elements.
DenseDoubleMatrix1D(double[]) - Constructor for class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Constructs a matrix with a copy of the given values.
DenseDoubleMatrix1D(int) - Constructor for class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Constructs a matrix with a given number of cells.
DenseDoubleMatrix1D(int, double[], int, int, boolean) - Constructor for class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Constructs a matrix with the given parameters.
DenseDoubleMatrix2D - Class in cern.colt.matrix.impl
Dense 2-d matrix holding double elements.
DenseDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix2D
Constructs a matrix with a copy of the given values.
DenseDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseDoubleMatrix2D - Class in cern.colt.matrix.tdouble.impl
Dense 2-d matrix holding double elements.
DenseDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Constructs a matrix with a copy of the given values.
DenseDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseDoubleMatrix2D(int, int, double[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Constructs a matrix with the given parameters.
DenseDoubleMatrix2D(MatrixVectorReader) - Constructor for class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Constructs a matrix from MatrixVectorReader.
DenseDoubleMatrix3D - Class in cern.colt.matrix.impl
Dense 3-d matrix holding double elements.
DenseDoubleMatrix3D(double[][][]) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix3D
Constructs a matrix with a copy of the given values.
DenseDoubleMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.impl.DenseDoubleMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
DenseDoubleMatrix3D - Class in cern.colt.matrix.tdouble.impl
Dense 3-d matrix holding double elements.
DenseDoubleMatrix3D(double[][][]) - Constructor for class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Constructs a matrix with a copy of the given values.
DenseDoubleMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
DenseDoubleMatrix3D(int, int, int, double[], int, int, int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Constructs a matrix with the given parameters.
DenseDoubleQRDecomposition - Class in cern.colt.matrix.tdouble.algo.decomposition
For an m x n matrix A with m >= n, the QR decomposition is an m x n orthogonal matrix Q and an n x n upper triangular matrix R so that A = Q*R.
DenseDoubleQRDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleQRDecomposition
Constructs and returns a new QR decomposition object; computed by Householder reflections; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
DenseDoubleSingularValueDecomposition - Class in cern.colt.matrix.tdouble.algo.decomposition
For an m x n matrix A, the singular value decomposition is an m x m orthogonal matrix U, an m x n diagonal matrix S, and an n x n orthogonal matrix V so that A = U*S*V'.
DenseDoubleSingularValueDecomposition(DoubleMatrix2D, boolean, boolean) - Constructor for class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleSingularValueDecomposition
Constructs and returns a new singular value decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
DenseFComplexMatrix1D - Class in cern.colt.matrix.tfcomplex.impl
Dense 1-d matrix (aka vector) holding complex elements.
DenseFComplexMatrix1D(float[]) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
Constructs a matrix with a copy of the given values.
DenseFComplexMatrix1D(FloatMatrix1D) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
Constructs a complex matrix with the same size as realPart matrix and fills the real part of this matrix with elements of realPart.
DenseFComplexMatrix1D(int) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
Constructs a matrix with a given number of cells.
DenseFComplexMatrix1D(int, float[], int, int, boolean) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
Constructs a matrix with the given parameters.
DenseFComplexMatrix2D - Class in cern.colt.matrix.tfcomplex.impl
Dense 2-d matrix holding complex elements.
DenseFComplexMatrix2D(float[][]) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
Constructs a matrix with a copy of the given values.
DenseFComplexMatrix2D(FloatMatrix2D) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
Constructs a complex matrix with the same size as realPart matrix and fills the real part of this matrix with elements of realPart.
DenseFComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseFComplexMatrix2D(int, int, float[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
Constructs a matrix with the given parameters.
DenseFComplexMatrix3D - Class in cern.colt.matrix.tfcomplex.impl
Dense 3-d matrix holding complex elements.
DenseFComplexMatrix3D(float[][][]) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
Constructs a matrix with a copy of the given values.
DenseFComplexMatrix3D(FloatMatrix3D) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
Constructs a matrix with the same size as realPart matrix and fills the real part of this matrix with elements of realPart.
DenseFComplexMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
DenseFComplexMatrix3D(int, int, int, float[], int, int, int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
Constructs a matrix with the given parameters.
DenseFloatAlgebra - Class in cern.colt.matrix.tfloat.algo
Linear algebraic matrix operations operating on dense matrices.
DenseFloatAlgebra() - Constructor for class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Constructs a new instance with an equality tolerance given by Property.DEFAULT.tolerance().
DenseFloatAlgebra(float) - Constructor for class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Constructs a new instance with the given equality tolerance.
DenseFloatCholeskyDecomposition - Class in cern.colt.matrix.tfloat.algo.decomposition
For a symmetric, positive definite matrix A, the Cholesky decomposition is a lower triangular matrix L so that A = L*L'; If the matrix is not symmetric or positive definite, the constructor returns a partial decomposition and sets an internal flag that may be queried by the isSymmetricPositiveDefinite() method.
DenseFloatCholeskyDecomposition(FloatMatrix2D) - Constructor for class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatCholeskyDecomposition
Constructs and returns a new Cholesky decomposition object for a symmetric and positive definite matrix; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
DenseFloatEigenvalueDecomposition - Class in cern.colt.matrix.tfloat.algo.decomposition
Eigenvalues and eigenvectors of a real matrix A.
DenseFloatEigenvalueDecomposition(FloatMatrix2D) - Constructor for class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatEigenvalueDecomposition
Constructs and returns a new eigenvalue decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
DenseFloatLUDecomposition - Class in cern.colt.matrix.tfloat.algo.decomposition
For an m x n matrix A with m >= n, the LU decomposition is an m x n unit lower triangular matrix L, an n x n upper triangular matrix U, and a permutation vector piv of length m so that A(piv,:) = L*U; If m < n, then L is m x m and U is m x n.
DenseFloatLUDecomposition(FloatMatrix2D) - Constructor for class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecomposition
Constructs and returns a new LU Decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
DenseFloatLUDecompositionQuick - Class in cern.colt.matrix.tfloat.algo.decomposition
A low level version of DenseFloatLUDecomposition, avoiding unnecessary memory allocation and copying.
DenseFloatLUDecompositionQuick() - Constructor for class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Constructs and returns a new LU Decomposition object with default tolerance 1.0E-9 for singularity detection.
DenseFloatLUDecompositionQuick(float) - Constructor for class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Constructs and returns a new LU Decomposition object which uses the given tolerance for singularity detection;
DenseFloatMatrix1D - Class in cern.colt.matrix.tfloat.impl
Dense 1-d matrix (aka vector) holding float elements.
DenseFloatMatrix1D(float[]) - Constructor for class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Constructs a matrix with a copy of the given values.
DenseFloatMatrix1D(int) - Constructor for class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Constructs a matrix with a given number of cells.
DenseFloatMatrix1D(int, float[], int, int, boolean) - Constructor for class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Constructs a matrix with the given parameters.
DenseFloatMatrix2D - Class in cern.colt.matrix.tfloat.impl
Dense 2-d matrix holding float elements.
DenseFloatMatrix2D(float[][]) - Constructor for class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Constructs a matrix with a copy of the given values.
DenseFloatMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseFloatMatrix2D(int, int, float[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Constructs a matrix with the given parameters.
DenseFloatMatrix2D(MatrixVectorReader) - Constructor for class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Constructs a matrix from MatrixVectorReader.
DenseFloatMatrix3D - Class in cern.colt.matrix.tfloat.impl
Dense 3-d matrix holding float elements.
DenseFloatMatrix3D(float[][][]) - Constructor for class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Constructs a matrix with a copy of the given values.
DenseFloatMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
DenseFloatMatrix3D(int, int, int, float[], int, int, int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Constructs a matrix with the given parameters.
DenseFloatQRDecomposition - Class in cern.colt.matrix.tfloat.algo.decomposition
For an m x n matrix A with m >= n, the QR decomposition is an m x n orthogonal matrix Q and an n x n upper triangular matrix R so that A = Q*R.
DenseFloatQRDecomposition(FloatMatrix2D) - Constructor for class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatQRDecomposition
Constructs and returns a new QR decomposition object; computed by Householder reflections; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
DenseFloatSingularValueDecomposition - Class in cern.colt.matrix.tfloat.algo.decomposition
For an m x n matrix A, the singular value decomposition is an m x m orthogonal matrix U, an m x n diagonal matrix S, and an n x n orthogonal matrix V so that A = U*S*V'.
DenseFloatSingularValueDecomposition(FloatMatrix2D, boolean, boolean) - Constructor for class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatSingularValueDecomposition
Constructs and returns a new singular value decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
DenseIntMatrix1D - Class in cern.colt.matrix.tint.impl
Dense 1-d matrix (aka vector) holding int elements.
DenseIntMatrix1D(int[]) - Constructor for class cern.colt.matrix.tint.impl.DenseIntMatrix1D
Constructs a matrix with a copy of the given values.
DenseIntMatrix1D(int) - Constructor for class cern.colt.matrix.tint.impl.DenseIntMatrix1D
Constructs a matrix with a given number of cells.
DenseIntMatrix1D(int, int[], int, int, boolean) - Constructor for class cern.colt.matrix.tint.impl.DenseIntMatrix1D
Constructs a matrix with the given parameters.
DenseIntMatrix2D - Class in cern.colt.matrix.tint.impl
Dense 2-d matrix holding int elements.
DenseIntMatrix2D(int[][]) - Constructor for class cern.colt.matrix.tint.impl.DenseIntMatrix2D
Constructs a matrix with a copy of the given values.
DenseIntMatrix2D(int, int) - Constructor for class cern.colt.matrix.tint.impl.DenseIntMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseIntMatrix2D(int, int, int[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tint.impl.DenseIntMatrix2D
Constructs a view with the given parameters.
DenseIntMatrix3D - Class in cern.colt.matrix.tint.impl
Dense 3-d matrix holding int elements.
DenseIntMatrix3D(int[][][]) - Constructor for class cern.colt.matrix.tint.impl.DenseIntMatrix3D
Constructs a matrix with a copy of the given values.
DenseIntMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tint.impl.DenseIntMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
DenseIntMatrix3D(int, int, int, int[], int, int, int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tint.impl.DenseIntMatrix3D
Constructs a view with the given parameters.
DenseLargeDComplexMatrix2D - Class in cern.colt.matrix.tdcomplex.impl
Dense 2-d matrix holding complex elements.
Implementation:
DenseLargeDComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
 
DenseLargeDComplexMatrix3D - Class in cern.colt.matrix.tdcomplex.impl
Dense 3-d matrix holding complex elements.
Implementation:
DenseLargeDComplexMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix3D
 
DenseLargeDoubleMatrix2D - Class in cern.colt.matrix.tdouble.impl
Dense 2-d matrix holding double elements.
DenseLargeDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
 
DenseLargeDoubleMatrix3D - Class in cern.colt.matrix.tdouble.impl
Dense 3-d matrix holding double elements.
DenseLargeDoubleMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
 
DenseLargeFComplexMatrix2D - Class in cern.colt.matrix.tfcomplex.impl
Dense 2-d matrix holding complex elements.
Implementation:
DenseLargeFComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
 
DenseLargeFComplexMatrix3D - Class in cern.colt.matrix.tfcomplex.impl
Dense 3-d matrix holding complex elements.
Implementation:
DenseLargeFComplexMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix3D
 
DenseLargeFloatMatrix2D - Class in cern.colt.matrix.tfloat.impl
Dense 2-d matrix holding float elements.
DenseLargeFloatMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
 
DenseLargeFloatMatrix3D - Class in cern.colt.matrix.tfloat.impl
Dense 3-d matrix holding float elements.
DenseLargeFloatMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
 
DenseLargeIntMatrix2D - Class in cern.colt.matrix.tint.impl
Dense 2-d matrix holding int elements.
DenseLargeIntMatrix2D(int, int) - Constructor for class cern.colt.matrix.tint.impl.DenseLargeIntMatrix2D
 
DenseLargeIntMatrix3D - Class in cern.colt.matrix.tint.impl
Dense 3-d matrix holding int elements.
DenseLargeIntMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tint.impl.DenseLargeIntMatrix3D
 
DenseLargeLongMatrix2D - Class in cern.colt.matrix.tlong.impl
Dense 2-d matrix holding long elements.
DenseLargeLongMatrix2D(int, int) - Constructor for class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix2D
 
DenseLargeLongMatrix3D - Class in cern.colt.matrix.tlong.impl
Dense 3-d matrix holding long elements.
DenseLargeLongMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix3D
 
DenseLargeObjectMatrix2D - Class in cern.colt.matrix.tobject.impl
Dense 2-d matrix holding Object elements.
DenseLargeObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix2D
 
DenseLargeObjectMatrix3D - Class in cern.colt.matrix.tobject.impl
Dense 3-d matrix holding Object elements.
DenseLargeObjectMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix3D
 
DenseLongMatrix1D - Class in cern.colt.matrix.tlong.impl
Dense 1-d matrix (aka vector) holding int elements.
DenseLongMatrix1D(long[]) - Constructor for class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
Constructs a matrix with a copy of the given values.
DenseLongMatrix1D(int) - Constructor for class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
Constructs a matrix with a given number of cells.
DenseLongMatrix1D(int, long[], int, int, boolean) - Constructor for class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
Constructs a matrix with the given parameters.
DenseLongMatrix2D - Class in cern.colt.matrix.tlong.impl
Dense 2-d matrix holding int elements.
DenseLongMatrix2D(long[][]) - Constructor for class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
Constructs a matrix with a copy of the given values.
DenseLongMatrix2D(int, int) - Constructor for class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseLongMatrix2D(int, int, long[], int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
Constructs a view with the given parameters.
DenseLongMatrix3D - Class in cern.colt.matrix.tlong.impl
Dense 3-d matrix holding int elements.
DenseLongMatrix3D(long[][][]) - Constructor for class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
Constructs a matrix with a copy of the given values.
DenseLongMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
DenseLongMatrix3D(int, int, int, long[], int, int, int, int, int, int, boolean) - Constructor for class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
Constructs a view with the given parameters.
DenseObjectMatrix1D - Class in cern.colt.matrix.impl
Dense 1-d matrix (aka vector) holding Object elements.
DenseObjectMatrix1D(Object[]) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix1D
Constructs a matrix with a copy of the given values.
DenseObjectMatrix1D(int) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix1D
Constructs a matrix with a given number of cells.
DenseObjectMatrix1D - Class in cern.colt.matrix.tobject.impl
Dense 1-d matrix (aka vector) holding Object elements.
DenseObjectMatrix1D(Object[]) - Constructor for class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Constructs a matrix with a copy of the given values.
DenseObjectMatrix1D(int) - Constructor for class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Constructs a matrix with a given number of cells.
DenseObjectMatrix2D - Class in cern.colt.matrix.impl
Dense 2-d matrix holding Object elements.
DenseObjectMatrix2D(Object[][]) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix2D
Constructs a matrix with a copy of the given values.
DenseObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseObjectMatrix2D - Class in cern.colt.matrix.tobject.impl
Dense 2-d matrix holding Object elements.
DenseObjectMatrix2D(Object[][]) - Constructor for class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Constructs a matrix with a copy of the given values.
DenseObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
DenseObjectMatrix3D - Class in cern.colt.matrix.impl
Dense 3-d matrix holding Object elements.
DenseObjectMatrix3D(Object[][][]) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix3D
Constructs a matrix with a copy of the given values.
DenseObjectMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.impl.DenseObjectMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
DenseObjectMatrix3D - Class in cern.colt.matrix.tobject.impl
Dense 3-d matrix holding Object elements.
DenseObjectMatrix3D(Object[][][]) - Constructor for class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
Constructs a matrix with a copy of the given values.
DenseObjectMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
Constructs a matrix with a given number of slices, rows and columns.
density(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Returns the matrix's fraction of non-zero cells; A.cardinality() / A.size().
density(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Returns the matrix's fraction of non-zero cells; A.cardinality() / A.size().
density(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Returns the matrix's fraction of non-zero cells; A.cardinality() / A.size().
density(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
Returns the matrix's fraction of non-zero cells; A.cardinality() / A.size().
density(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Returns the matrix's fraction of non-zero cells; A.cardinality() / A.size().
density(double) - Method in class org.apache.commons.math.distribution.AbstractContinuousDistribution
Return the probability density for a particular point.
density(Double) - Method in interface org.apache.commons.math.distribution.BetaDistribution
Return the probability density for a particular point.
density(Double) - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
Deprecated.  
density(double) - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
Return the probability density for a particular point.
density(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Returns the probability density for a particular point.
density(Double) - Method in interface org.apache.commons.math.distribution.ChiSquaredDistribution
Return the probability density for a particular point.
density(Double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Deprecated.  
density(double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Return the probability density for a particular point.
density(Double) - Method in interface org.apache.commons.math.distribution.ExponentialDistribution
Return the probability density for a particular point.
density(Double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Deprecated. - use density(double)
density(double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Return the probability density for a particular point.
density(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
Returns the probability density for a particular point.
density(Double) - Method in interface org.apache.commons.math.distribution.GammaDistribution
Return the probability density for a particular point.
density(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Returns the probability density for a particular point.
density(Double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Deprecated.  
density(P) - Method in interface org.apache.commons.math.distribution.HasDensity
Deprecated. Compute the probability density function.
density(Double) - Method in interface org.apache.commons.math.distribution.NormalDistribution
Return the probability density for a particular point.
density(Double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Deprecated.  
density(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Returns the probability density for a particular point.
density(double) - Method in class org.apache.commons.math.distribution.TDistributionImpl
Returns the probability density for a particular point.
density(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Returns the probability density for a particular point.
density(double) - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
Computes the density of the Anderson-Darling distribution with parameter n.
density(double) - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDistQuick
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDistQuick
Computes the density of the distribution with parameter n.
density(double) - Method in class umontreal.iro.lecuyer.probdist.BetaDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Same as density (alpha, beta, 0, 1, x).
density(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Computes the density function of the beta distribution.
density(double, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Returns the density evaluated at x.
density(double) - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.CauchyDist
Computes the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.ChiDist
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiDist
Computes the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Computes the density function for a chi-square distribution with n degrees of freedom.
density(double) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Computes the density function for a noncentral chi-square distribution with ν = nu degrees of freedom and parameter λ = lambda.
density(double) - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Returns f (x), the density evaluated at x.
density(double) - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Computes the density function for a Cramér-von Mises distribution with parameter n.
density(int, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ErlangDist
Computes the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
 
density(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Computes the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated.  
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Computes the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
 
density(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Computes the density for the fatigue life distribution with parameters μ, β and γ.
density(double) - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
 
density(int, int, double) - Static method in class umontreal.iro.lecuyer.probdist.FisherFDist
Computes the density function for a Fisher F distribution with n and m degrees of freedom.
density(double) - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Computes the density function of the folded normal distribution.
density(double) - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
 
density(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FrechetDist
Computes and returns the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.GammaDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Computes the density function at x.
density(double) - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Computes and returns the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Computes the density function of the half-normal distribution.
density(double) - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Computes the density function for a hyperbolic secant distribution with parameters μ and σ.
density(double) - Method in class umontreal.iro.lecuyer.probdist.InverseDistFromDensity
Computes the probability density at x.
density(double) - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Computes the density function of the inverse gamma distribution with shape parameter α and scale parameter β.
density(double) - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Computes the density function for the inverse gaussian distribution with parameters μ and λ, evaluated at x.
density(double) - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
 
density(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Computes the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
 
density(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Computes the density function f (x).
density(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
Computes the density for the distribution with parameter n.
density(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDistQuick
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDistQuick
Computes the density for the distribution with parameter n.
density(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
Computes the density of the Kolmogorov-Smirnov+ distribution with parameter n.
density(double) - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Computes the Laplace density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LogisticDist
Computes the density function f (x).
density(double) - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Computes the density function for a log-logisitic distribution with parameters α and β.
density(double) - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LognormalDist
Computes the lognormal density function f (x).
density(double) - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
 
density(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Computes the density function of the Nakagami distribution.
density(double) - Method in class umontreal.iro.lecuyer.probdist.NormalDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Computes the normal density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
 
density(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Computes the density function for the normal inverse gaussian distribution with parameters α, β, μ and δ, evaluated at x.
density(double) - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ParetoDist
Computes the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Computes the density function of a Pearson V distribution with shape parameter α and scale parameter β.
density(double) - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
 
density(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Computes the density function of a Pearson VI distribution with shape parameters α1 and α2, and scale parameter β.
density(double) - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
 
density(double) - Method in class umontreal.iro.lecuyer.probdist.PowerDist
 
density(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.PowerDist
Computes the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Computes the density function.
density(double, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Same as density (0, beta, x).
density(double) - Method in class umontreal.iro.lecuyer.probdist.StudentDist
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.StudentDist
Computes the density function of a Student t-distribution with n degrees of freedom.
density(double) - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
 
density(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.TriangularDist
Computes the density function.
density(double) - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
 
density(double) - Method in class umontreal.iro.lecuyer.probdist.UniformDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.UniformDist
Computes the uniform density function f (x).
density(double) - Method in class umontreal.iro.lecuyer.probdist.WatsonGDist
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.WatsonGDist
Computes the density function for a Watson G distribution with parameter n.
density(double) - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
 
density(int, double) - Static method in class umontreal.iro.lecuyer.probdist.WatsonUDist
Computes the density of the Watson U distribution with parameter n.
density(double) - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
 
density(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Computes the density function.
density(double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Same as density (alpha, 1, 0, x).
density(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
 
density(double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Computes the standard binormal density function with μ1 = μ2 = 0 and σ1 = σ2 = 1.
density(double, double, double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Computes the binormal density function with parameters μ1 = mu1, μ2 = mu2, σ1 = sigma1, σ2 = sigma2 and ρ = rho.
density(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
 
density(int, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
Computes the standard bivariate Student's t density function with correlation ρ = rho and ν = nu degrees of freedom.
density(double, double) - Method in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistribution2Dim
Returns f (x, y), the density of (X, Y) evaluated at (x, y).
density(double[]) - Method in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistribution2Dim
Simply calls density (x[0], x[1]).
density(double[]) - Method in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistributionMulti
Returns f (x1, x2,…, xd), the probability density of X evaluated at the point x, where x = {x1, x2,…, xd}.
density(double[]) - Method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
 
density(double[], double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
Computes the density of the Dirichlet distribution with parameters (α1,...,αd).
density(double[]) - Method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
 
density(double[], double[][], double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Computes the density of the multinormal distribution with parameters μ = mu and Σ = sigma, evaluated at x.
density01(double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Same as density (0, 1, x).
deriv(double, double) - Method in interface flanagan.integration.DerivFunction
 
derivative() - Method in class jhplot.P1D
Calculate derivative for X-Y data points.
derivative() - Method in interface org.apache.commons.math.analysis.DifferentiableUnivariateMatrixFunction
Returns the derivative of the function
derivative() - Method in interface org.apache.commons.math.analysis.DifferentiableUnivariateRealFunction
Returns the derivative of the function
derivative() - Method in interface org.apache.commons.math.analysis.DifferentiableUnivariateVectorialFunction
Returns the derivative of the function
derivative() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Returns the derivative as a UnivariateRealFunction
derivative() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialSplineFunction
Returns the derivative of the polynomial spline function as a UnivariateRealFunction
derivative() - Method in class org.apache.commons.math.optimization.fitting.GaussianFunction
Returns the derivative of the function
derivative() - Method in class org.apache.commons.math.optimization.fitting.HarmonicFunction
Returns the derivative of the function
derivative(double) - Method in class umontreal.iro.lecuyer.functionfit.BSpline
 
derivative(double, int) - Method in class umontreal.iro.lecuyer.functionfit.BSpline
 
derivative(double) - Method in class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Evaluates and returns the value of the first derivative of the spline at z.
derivative(double, int) - Method in class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Evaluates and returns the value of the n-th derivative of the spline at z.
derivative(double, int) - Method in class umontreal.iro.lecuyer.functions.AverageMathFunction
 
derivative(double) - Method in class umontreal.iro.lecuyer.functions.AverageMathFunction
 
derivative(double) - Method in class umontreal.iro.lecuyer.functions.IdentityMathFunction
 
derivative(double, int) - Method in class umontreal.iro.lecuyer.functions.IdentityMathFunction
 
derivative(MathFunction, double) - Static method in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Returns the first derivative of the function func evaluated at x.
derivative(MathFunction, double, int) - Static method in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Returns the nth derivative of function func evaluated at x.
derivative(double, int) - Method in interface umontreal.iro.lecuyer.functions.MathFunctionWithDerivative
Computes (or estimates) the nth derivative of the function at point x.
derivative(double) - Method in interface umontreal.iro.lecuyer.functions.MathFunctionWithFirstDerivative
Computes (or estimates) the first derivative of the function at point x.
derivative(double) - Method in class umontreal.iro.lecuyer.functions.Polynomial
 
derivative(double, int) - Method in class umontreal.iro.lecuyer.functions.Polynomial
 
derivative(double) - Method in class umontreal.iro.lecuyer.functions.PowerMathFunction
 
derivative(double) - Method in class umontreal.iro.lecuyer.functions.ShiftedMathFunction
 
derivative(double, int) - Method in class umontreal.iro.lecuyer.functions.ShiftedMathFunction
 
derivative(double) - Method in class umontreal.iro.lecuyer.functions.SquareMathFunction
 
derivative(double) - Method in class umontreal.iro.lecuyer.simevents.Continuous
This method should return the derivative of this variable with respect to time, at time t.
derivativeBSpline() - Method in class umontreal.iro.lecuyer.functionfit.BSpline
Returns the derivative B-spline object of the current variable.
derivativeBSpline(int) - Method in class umontreal.iro.lecuyer.functionfit.BSpline
Returns the ith derivative B-spline object of the current variable; i must be less than the degree of the original B-spline.
DerivativeException - Exception in org.apache.commons.math.ode
This exception is made available to users to report the error conditions that are triggered while computing the differential equations.
DerivativeException(String, Object...) - Constructor for exception org.apache.commons.math.ode.DerivativeException
Simple constructor.
DerivativeException(Localizable, Object...) - Constructor for exception org.apache.commons.math.ode.DerivativeException
Simple constructor.
DerivativeException(Throwable) - Constructor for exception org.apache.commons.math.ode.DerivativeException
Build an instance from an underlying cause.
derivativePolynomial(int) - Method in class umontreal.iro.lecuyer.functions.Polynomial
Returns a polynomial corresponding to the nth derivative of this polynomial.
DerivFunction - Interface in flanagan.integration
 
derivn(double, double[]) - Method in interface flanagan.integration.DerivnFunction
 
DerivnFunction - Interface in flanagan.integration
 
descending(int) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with cells having descending values.
descending(int, int) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with cells having descending values.
descending(int, int, int) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with cells having descending values.
descending(int) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
Constructs a matrix with cells having descending values.
descending(int, int) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a matrix with cells having descending values.
descending(int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleFactory3D
Constructs a matrix with cells having descending values.
descending(int) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
Constructs a matrix with cells having descending values.
descending(int, int) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a matrix with cells having descending values.
descending(int, int, int) - Method in class cern.colt.matrix.tfloat.FloatFactory3D
Constructs a matrix with cells having descending values.
descending(int) - Method in class cern.colt.matrix.tint.IntFactory1D
Constructs a matrix with cells having descending values.
descending(int, int) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a matrix with cells having descending values.
descending(int, int, int) - Method in class cern.colt.matrix.tint.IntFactory3D
Constructs a matrix with cells having descending values.
descending(int) - Method in class cern.colt.matrix.tlong.LongFactory1D
Constructs a matrix with cells having descending values.
descending(int, int) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a matrix with cells having descending values.
descending(int, int, int) - Method in class cern.colt.matrix.tlong.LongFactory3D
Constructs a matrix with cells having descending values.
description(int) - Method in class hep.aida.ref.dataset.DataStatistics
Get the description corresponding to a coordinate.
Descriptive - Class in cern.jet.stat
Basic descriptive statistics.
DescriptiveStatistics - Class in org.apache.commons.math.stat.descriptive
Maintains a dataset of values of a single variable and computes descriptive statistics based on stored data.
DescriptiveStatistics() - Constructor for class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with an infinite window
DescriptiveStatistics(int) - Constructor for class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with the specified window
DescriptiveStatistics(double[]) - Constructor for class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Construct a DescriptiveStatistics instance with an infinite window and the initial data values in double[] initialDoubleArray.
DescriptiveStatistics(DescriptiveStatistics) - Constructor for class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Copy constructor.
deserializeRealMatrix(Object, String, ObjectInputStream) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deserialize a RealMatrix field in a class.
deserializeRealVector(Object, String, ObjectInputStream) - Static method in class org.apache.commons.math.linear.MatrixUtils
Deserialize a RealVector field in a class.
destroy(IDataPointSet) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
destroy(IBaseHistogram) - Method in class hep.aida.ref.histogram.HistogramFactory
Destroy an IBaseHistogram ogject.
destroy() - Method in class jhplot.HChart
Remove the canvas frame
destroy() - Method in class jhplot.HGraph
Destroy the canvas frame
destroy() - Method in class jhplot.HPlot3DP
Destroy the canvas frame
destroy() - Method in class jhplot.HView3D
Destroy the canvas frame
det(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the determinant of matrix A.
det() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns the determinant, det(A).
det() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns the determinant, det(A).
det() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecomposition
Returns the determinant, det(A).
det() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Returns the determinant, det(A).
det() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleLUDecomposition
Returns the determinant, det(A).
det(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the determinant of matrix A.
det(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Returns the determinant of matrix A.
det() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecomposition
Returns the determinant, det(A).
det() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Returns the determinant, det(A).
det() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatLUDecomposition
Returns the determinant, det(A).
det(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the determinant of matrix A.
det(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Returns the determinant of matrix A.
det() - Method in class hephysics.matrix.BasicMatrix
 
det(Matrix) - Static method in class hephysics.matrix.MatrixOp
 
det() - Method in class hephysics.matrix.SymmetricMatrix
 
det() - Method in class hephysics.vec.Hep3Matrix
Returns the determinent of the matrix.
det(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
det() - Method in class jhplot.math.LUDecomposition
Determinant
determinant() - Method in class flanagan.math.Matrix
 
determinant(Matrix) - Static method in class flanagan.math.Matrix
 
determinant(double[][]) - Static method in class flanagan.math.Matrix
 
Dfp - Class in org.apache.commons.math.dfp
Decimal floating point library for Java
Dfp(Dfp) - Constructor for class org.apache.commons.math.dfp.Dfp
Copy constructor.
DfpDec - Class in org.apache.commons.math.dfp
Subclass of Dfp which hides the radix-10000 artifacts of the superclass.
DfpDec(Dfp) - Constructor for class org.apache.commons.math.dfp.DfpDec
Copy constructor.
DfpField - Class in org.apache.commons.math.dfp
Field for Decimal floating point instances.
DfpField(int) - Constructor for class org.apache.commons.math.dfp.DfpField
Create a factory for the specified number of radix digits.
DfpField.RoundingMode - Enum in org.apache.commons.math.dfp
Enumerate for rounding modes.
DfpMath - Class in org.apache.commons.math.dfp
Mathematical routines for use with Dfp.
dgbbrd(String, int, int, int, int, int, double[], int, double[], double[], double[], int, double[], int, double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgbcon(String, int, int, int, double[], int, int[], double, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgbequ(int, int, int, int, double[], int, double[], double[], doubleW, doubleW, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dgbmv(String, int, int, int, int, double, double[], int, double[], int, double, double[], int) - Method in class org.netlib.blas.BLAS
..
dgbrfs(String, int, int, int, int, double[], int, double[], int, int[], double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgbsv(int, int, int, int, double[], int, int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgbsvx(String, String, int, int, int, int, double[], int, double[], int, int[], StringW, double[], double[], double[], int, double[], int, doubleW, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgbtf2(int, int, int, int, double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgbtrf(int, int, int, int, double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgbtrs(String, int, int, int, int, double[], int, int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgebak(String, String, int, int, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgebal(String, int, double[], int, intW, intW, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgebd2(int, int, double[], int, double[], double[], double[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgebrd(int, int, double[], int, double[], double[], double[], double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgecon(String, int, double[], int, double, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgeequ(int, int, double[], int, double[], double[], doubleW, doubleW, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dgees(String, String, Object, int, double[], int, intW, double[], double[], double[], int, double[], int, boolean[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgeesx(String, String, Object, String, int, double[], int, intW, double[], double[], double[], int, doubleW, doubleW, double[], int, int[], int, boolean[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgeev(String, String, int, double[], int, double[], double[], double[], int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgeevx(String, String, String, String, int, double[], int, double[], double[], double[], int, double[], int, intW, intW, double[], doubleW, double[], double[], double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgegs(String, String, int, double[], int, double[], int, double[], double[], double[], double[], int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgegv(String, String, int, double[], int, double[], int, double[], double[], double[], double[], int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgehd2(int, int, int, double[], int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgehrd(int, int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgelq2(int, int, double[], int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgelqf(int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgels(String, int, int, int, double[], int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgelsd(int, int, int, double[], int, double[], int, double[], double, intW, double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgelss(int, int, int, double[], int, double[], int, double[], double, intW, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgelsx(int, int, int, double[], int, double[], int, int[], double, intW, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgelsy(int, int, int, double[], int, double[], int, int[], double, intW, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgemm(boolean, boolean, double, DoubleMatrix2D, DoubleMatrix2D, double, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Generalized linear algebraic matrix-matrix multiply; C = alpha*A*B + beta*C.
dgemm(boolean, boolean, double, DoubleMatrix2D, DoubleMatrix2D, double, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dgemm(boolean, boolean, double, DoubleMatrix2D, DoubleMatrix2D, double, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dgemm(boolean, boolean, double, DoubleMatrix2D, DoubleMatrix2D, double, DoubleMatrix2D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Generalized linear algebraic matrix-matrix multiply; C = alpha*A*B + beta*C.
dgemm(boolean, boolean, double, DoubleMatrix2D, DoubleMatrix2D, double, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dgemm(boolean, boolean, float, FloatMatrix2D, FloatMatrix2D, float, FloatMatrix2D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Generalized linear algebraic matrix-matrix multiply; C = alpha*A*B + beta*C.
dgemm(boolean, boolean, float, FloatMatrix2D, FloatMatrix2D, float, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dgemm(String, String, int, int, int, double, double[], int, double[], int, double, double[], int) - Method in class org.netlib.blas.BLAS
..
dgemv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Generalized linear algebraic matrix-vector multiply; y = alpha*A*x + beta*y.
dgemv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dgemv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dgemv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Generalized linear algebraic matrix-vector multiply; y = alpha*A*x + beta*y.
dgemv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dgemv(boolean, float, FloatMatrix2D, FloatMatrix1D, float, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Generalized linear algebraic matrix-vector multiply; y = alpha*A*x + beta*y.
dgemv(boolean, float, FloatMatrix2D, FloatMatrix1D, float, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dgemv(String, int, int, double, double[], int, double[], int, double, double[], int) - Method in class org.netlib.blas.BLAS
..
dgeql2(int, int, double[], int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgeqlf(int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgeqp3(int, int, double[], int, int[], double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgeqpf(int, int, double[], int, int[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgeqr2(int, int, double[], int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgeqrf(int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dger(double, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Performs a rank 1 update; A = A + alpha*x*y'.
dger(double, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dger(double, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dger(double, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Performs a rank 1 update; A = A + alpha*x*y'.
dger(double, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dger(float, FloatMatrix1D, FloatMatrix1D, FloatMatrix2D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Performs a rank 1 update; A = A + alpha*x*y'.
dger(float, FloatMatrix1D, FloatMatrix1D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dger(int, int, double, double[], int, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dgerfs(String, int, int, double[], int, double[], int, int[], double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgerq2(int, int, double[], int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgerqf(int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgesc2(int, double[], int, double[], int[], int[], doubleW) - Method in class org.netlib.lapack.LAPACK
..
dgesdd(String, int, int, double[], int, double[], double[], int, double[], int, double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgesv(int, int, double[], int, int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgesvd(String, String, int, int, double[], int, double[], double[], int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgesvx(String, String, int, int, double[], int, double[], int, int[], StringW, double[], double[], double[], int, double[], int, doubleW, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgetc2(int, double[], int, int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgetf2(int, int, double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgetrf(int, int, double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgetri(int, double[], int, int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgetrs(String, int, int, double[], int, int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgetv0(intW, String, int, boolean, int, int, double[], int, double[], doubleW, int[], double[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dggbak(String, String, int, int, int, double[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dggbal(String, int, double[], int, double[], int, intW, intW, double[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgges(String, String, String, Object, int, double[], int, double[], int, intW, double[], double[], double[], double[], int, double[], int, double[], int, boolean[], intW) - Method in class org.netlib.lapack.LAPACK
..
dggesx(String, String, String, Object, String, int, double[], int, double[], int, intW, double[], double[], double[], double[], int, double[], int, double[], double[], double[], int, int[], int, boolean[], intW) - Method in class org.netlib.lapack.LAPACK
..
dggev(String, String, int, double[], int, double[], int, double[], double[], double[], double[], int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dggevx(String, String, String, String, int, double[], int, double[], int, double[], double[], double[], double[], int, double[], int, intW, intW, double[], double[], doubleW, doubleW, double[], double[], double[], int, int[], boolean[], intW) - Method in class org.netlib.lapack.LAPACK
..
dggglm(int, int, int, double[], int, double[], int, double[], double[], double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgghrd(String, String, int, int, int, double[], int, double[], int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgglse(int, int, int, double[], int, double[], int, double[], double[], double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dggqrf(int, int, int, double[], int, double[], double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dggrqf(int, int, int, double[], int, double[], double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dggsvd(String, String, String, int, int, int, intW, intW, double[], int, double[], int, double[], double[], double[], int, double[], int, double[], int, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dggsvp(String, String, String, int, int, int, double[], int, double[], int, double, double, intW, intW, double[], int, double[], int, double[], int, int[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgtcon(String, int, double[], double[], double[], double[], int[], double, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgtrfs(String, int, int, double[], double[], double[], double[], double[], double[], double[], int[], double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgtsv(int, int, double[], double[], double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgtsvx(String, String, int, int, double[], double[], double[], double[], double[], double[], double[], int[], double[], int, double[], int, doubleW, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgttrf(int, double[], double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dgttrs(String, int, int, double[], double[], double[], double[], int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dgtts2(int, int, int, double[], double[], double[], double[], int[], double[], int) - Method in class org.netlib.lapack.LAPACK
..
dhgeqz(String, String, String, int, int, int, double[], int, double[], int, double[], double[], double[], double[], int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dhsein(String, String, String, boolean[], int, double[], int, double[], double[], double[], int, double[], int, int, intW, double[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dhseqr(String, String, int, int, int, double[], int, double[], double[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dht() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Computes the discrete Hartley transform (DHT) of this matrix.
dht() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Computes the discrete Hartley transform (DHT) of this matrix.
dht2() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the 2D discrete Hartley transform (DHT) of this matrix.
dht2() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the 2D discrete Hartley transform (DHT) of this matrix.
dht2() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the 2D discrete Hartley transform (DHT) of this matrix.
dht2() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the 2D discrete Hartley transform (DHT) of this matrix.
dht2() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the 2D discrete Hartley transform (DHT) of this matrix.
dht2() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the 2D discrete Hartley transform (DHT) of this matrix.
dht2() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the 2D discrete Hartley transform (DHT) of this matrix.
dht2() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the 2D discrete Hartley transform (DHT) of this matrix.
dht2Slices() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 2D discrete Hartley transform (DHT) of each slice of this matrix.
dht2Slices() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 2D discrete Hartley transform (DHT) of each slice of this matrix.
dht2Slices() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 2D discrete Hertley transform (DHT) of each column of this matrix.
dht2Slices() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 2D discrete Hartley transform (DHT) of each slice of this matrix.
dht2Slices() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 2D discrete Hartley transform (DHT) of each slice of this matrix.
dht2Slices() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 2D discrete Hertley transform (DHT) of each column of this matrix.
dht3() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 3D discrete Hartley transform (DHT) of this matrix.
dht3() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 3D discrete Hartley transform (DHT) of this matrix.
dht3() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 3D discrete Hartley transform (DHT) of this matrix.
dht3() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 3D discrete Hartley transform (DHT) of this matrix.
dht3() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 3D discrete Hartley transform (DHT) of this matrix.
dht3() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 3D discrete Hartley transform (DHT) of this matrix.
dhtColumns() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the discrete Hartley transform (DHT) of each column of this matrix.
dhtColumns() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the discrete Hartley transform (DHT) of each column of this matrix.
dhtColumns() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the discrete Hartley transform (DHT) of each column of this matrix.
dhtColumns() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the discrete Hertley transform (DHT) of each column of this matrix.
dhtColumns() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the discrete Hartley transform (DHT) of each column of this matrix.
dhtColumns() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the discrete Hartley transform (DHT) of each column of this matrix.
dhtColumns() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the discrete Hartley transform (DHT) of each column of this matrix.
dhtColumns() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the discrete Hertley transform (DHT) of each column of this matrix.
dhtRows() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the discrete Hartley transform (DHT) of each row of this matrix.
dhtRows() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the discrete Hartley transform (DHT) of each row of this matrix.
dhtRows() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the discrete Hartley transform (DHT) of each row of this matrix.
dhtRows() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the discrete Hertley transform (DHT) of each row of this matrix.
dhtRows() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the discrete Hartley transform (DHT) of each row of this matrix.
dhtRows() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the discrete Hartley transform (DHT) of each row of this matrix.
dhtRows() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the discrete Hartley transform (DHT) of each row of this matrix.
dhtRows() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the discrete Hertley transform (DHT) of each row of this matrix.
diagonal(DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a new vector consisting of the diagonal elements of A.
diagonal(ObjectMatrix1D) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(ObjectMatrix2D) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a new vector consisting of the diagonal elements of A.
diagonal(DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a new vector consisting of the diagonal elements of A .
diagonal(double[]) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a new vector consisting of the diagonal elements of A .
diagonal(FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a new vector consisting of the diagonal elements of A .
diagonal(float[]) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a new vector consisting of the diagonal elements of A .
diagonal(IntMatrix1D) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(int[]) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(IntMatrix2D) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a new vector consisting of the diagonal elements of A .
diagonal(LongMatrix1D) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(int[]) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(LongMatrix2D) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a new vector consisting of the diagonal elements of A .
diagonal(ObjectMatrix1D) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
Constructs a new diagonal matrix whose diagonal elements are the elements of vector.
diagonal(ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
Constructs a new vector consisting of the diagonal elements of A .
diagonal(int) - Method in class hephysics.matrix.SymmetricMatrix
Returns the diagonal element for the given row/column
diagonal() - Method in class jhplot.bsom.Matrix
If the matrix is a row or column vector, make a diagonal matrix from it.
diagonal(int, double) - Static method in class jhplot.math.DoubleArray
Returns an m x m matrix.
diagonal(double...) - Static method in class jhplot.math.DoubleArray
Returns an m x m matrix.
DiagonalDComplexMatrix2D - Class in cern.colt.matrix.tdcomplex.impl
Diagonal 2-d matrix holding complex elements.
DiagonalDComplexMatrix2D(double[][], int) - Constructor for class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
Constructs a matrix with a copy of the given values.
DiagonalDComplexMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
DiagonalDoubleMatrix2D - Class in cern.colt.matrix.tdouble.impl
Diagonal 2-d matrix holding double elements.
DiagonalDoubleMatrix2D(double[][], int) - Constructor for class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
Constructs a matrix with a copy of the given values.
DiagonalDoubleMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
DiagonalFComplexMatrix2D - Class in cern.colt.matrix.tfcomplex.impl
Diagonal 2-d matrix holding complex elements.
DiagonalFComplexMatrix2D(float[][], int) - Constructor for class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
Constructs a matrix with a copy of the given values.
DiagonalFComplexMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
DiagonalFloatMatrix2D - Class in cern.colt.matrix.tfloat.impl
Diagonal 2-d matrix holding float elements.
DiagonalFloatMatrix2D(float[][], int) - Constructor for class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
Constructs a matrix with a copy of the given values.
DiagonalFloatMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
Constructs a matrix with a given number of rows and columns.
diagonalIndex() - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
Returns the index of the diagonal
diagonalIndex() - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
Returns the index of the diagonal
diagonalIndex() - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
Returns the index of the diagonal
diagonalIndex() - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
Returns the index of the diagonal
diagonalIndex() - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
Returns the index of the diagonal
diagonalIndex() - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
Returns the index of the diagonal
diagonalIndex() - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
Returns the index of the diagonal
DiagonalIntMatrix2D - Class in cern.colt.matrix.tint.impl
Diagonal 2-d matrix holding int elements.
DiagonalIntMatrix2D(int[][], int) - Constructor for class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
Constructs a matrix with a copy of the given values.
DiagonalIntMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
Constructs a matrix with a given number of rows and columns.
diagonalLength() - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
Returns the length of the diagonal
diagonalLength() - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
Returns the length of the diagonal
diagonalLength() - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
Returns the length of the diagonal
diagonalLength() - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
Returns the length of the diagonal
diagonalLength() - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
Returns the length of the diagonal
diagonalLength() - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
Returns the length of the diagonal
diagonalLength() - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
Returns the length of the diagonal
DiagonalLongMatrix2D - Class in cern.colt.matrix.tlong.impl
Diagonal 2-d matrix holding long elements.
DiagonalLongMatrix2D(long[][], int) - Constructor for class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
Constructs a matrix with a copy of the given values.
DiagonalLongMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
Constructs a matrix with a given number of rows and columns.
diagonalMatrix(int, double[]) - Static method in class flanagan.math.Matrix
 
diagonalMatrix(int, int, double[]) - Static method in class flanagan.math.Matrix
 
DiagonalObjectMatrix2D - Class in cern.colt.matrix.tobject.impl
Diagonal 2-d matrix holding Object elements.
DiagonalObjectMatrix2D(Object[][], int) - Constructor for class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
Constructs a matrix with a copy of the given values.
DiagonalObjectMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
Diagram - Class in jhplot.jadraw
Main static methods to build objects for Feynman diagrams.
Diagram() - Constructor for class jhplot.jadraw.Diagram
 
diff(String) - Method in class jhplot.FND
differentiate the expression and simplify
diff(IntArrayList, IntArrayList, int, int, int, int) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Assumes that the real-valued observations U0,..., UN-1 contained in sortedData are already sorted in increasing order and computes the differences between the successive observations.
diff(DoubleArrayList, DoubleArrayList, int, int, double, double) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Same as method diff(IntArrayList,IntArrayList,int,int,int,int), but for the continuous case.
DifferentiableMultivariateRealFunction - Interface in org.apache.commons.math.analysis
Extension of MultivariateRealFunction representing a differentiable multivariate real function.
DifferentiableMultivariateRealOptimizer - Interface in org.apache.commons.math.optimization
This interface represents an optimization algorithm for scalar differentiable objective functions.
DifferentiableMultivariateVectorialFunction - Interface in org.apache.commons.math.analysis
Extension of MultivariateVectorialFunction representing a differentiable multivariate vectorial function.
DifferentiableMultivariateVectorialOptimizer - Interface in org.apache.commons.math.optimization
This interface represents an optimization algorithm for vectorial differentiable objective functions.
DifferentiableUnivariateMatrixFunction - Interface in org.apache.commons.math.analysis
Extension of UnivariateMatrixFunction representing a differentiable univariate matrix function.
DifferentiableUnivariateRealFunction - Interface in org.apache.commons.math.analysis
Extension of UnivariateRealFunction representing a differentiable univariate real function.
DifferentiableUnivariateVectorialFunction - Interface in org.apache.commons.math.analysis
Extension of UnivariateVectorialFunction representing a differentiable univariate vectorial function.
differentiate(int, double, double) - Method in class jhplot.F1D
Numerical differentiation.
differentiate(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical differentiation.
differentiate(F1D, double[], double[]) - Static method in class jhplot.math.Numeric
Numerical differentiation in multiple dimensions.
digamma(double) - Static method in class org.apache.commons.math.special.Gamma
Computes the digamma function of x.
digamma(double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of the logarithmic derivative of the Gamma function ψ(x) = Γ'(x)/Γ(x).
DIGEST_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Use empirical distribution.
DigitalNet - Class in umontreal.iro.lecuyer.hups
This class provides the basic structures for storing and manipulating linear digital nets in base b, for an arbitrary base b >= 2.
DigitalNet() - Constructor for class umontreal.iro.lecuyer.hups.DigitalNet
Empty constructor.
DigitalNetBase2 - Class in umontreal.iro.lecuyer.hups
A special case of DigitalNet for the base b = 2.
DigitalNetBase2() - Constructor for class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
DigitalNetBase2FromFile - Class in umontreal.iro.lecuyer.hups
This class allows us to read the parameters defining a digital net in base 2 either from a file, or from a URL address on the World Wide Web.
DigitalNetBase2FromFile(String, int, int, int) - Constructor for class umontreal.iro.lecuyer.hups.DigitalNetBase2FromFile
Constructs a digital net in base 2 after reading its parameters from file filename.
DigitalNetBase2FromFile(String, int) - Constructor for class umontreal.iro.lecuyer.hups.DigitalNetBase2FromFile
Same as DigitalNetBase2FromFile(filename, r, 31, s1) where s1 is the dimension and r is given in data file filename.
DigitalNetFromFile - Class in umontreal.iro.lecuyer.hups
This class allows us to read the parameters defining a digital net either from a file, or from a URL address on the World Wide Web.
DigitalNetFromFile(String, int, int, int) - Constructor for class umontreal.iro.lecuyer.hups.DigitalNetFromFile
Constructs a digital net after reading its parameters from file filename.
DigitalNetFromFile(String, int) - Constructor for class umontreal.iro.lecuyer.hups.DigitalNetFromFile
Same as DigitalNetFromFile(filename, r, r, s) where s is the dimension and r is given in data file filename.
DigitalSequence - Class in umontreal.iro.lecuyer.hups
This abstract class describes methods specific to digital sequences.
DigitalSequence() - Constructor for class umontreal.iro.lecuyer.hups.DigitalSequence
 
DigitalSequenceBase2 - Class in umontreal.iro.lecuyer.hups
This abstract class describes methods specific to digital sequences in base 2.
DigitalSequenceBase2() - Constructor for class umontreal.iro.lecuyer.hups.DigitalSequenceBase2
 
dimen() - Method in class jhplot.VHolder
Return the dimension of the data
dimension() - Method in class hep.aida.ref.dataset.DataStatistics
Get the dimension of the DataStatistics.
dimension() - Method in class hep.aida.ref.fitter.fitdata.FitData
 
dimension() - Method in class hep.aida.ref.fitter.InternalFitFunction
 
dimension() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
dimension() - Method in class hep.aida.ref.function.AbstractIFunction
 
dimension() - Method in class hep.aida.ref.function.BaseModelFunction
 
dimension() - Method in class hep.aida.ref.function.ExponentModelFunction
 
dimension() - Method in class hep.aida.ref.function.FunctionCore
 
dimension() - Method in class hep.aida.ref.function.Grid
 
dimension() - Method in class hep.aida.ref.function.PolynomialModelFunction
 
dimension() - Method in class hep.aida.ref.function.SumOfFunctions
 
dimension() - Method in class hep.aida.ref.histogram.AbstractBaseHistogram
Get the dimension of the histogram.
dimension() - Method in class hep.aida.ref.histogram.DataPoint
 
dimension() - Method in class hep.aida.ref.histogram.DataPointSet
 
dimension() - Method in class jhplot.P1D
Returns the dimension of this P1D holder.
DimensionMismatchException - Exception in org.apache.commons.math
Deprecated. in 2.2 (to be removed in 3.0). Please use its equivalent from package org.apache.commons.math.exception.
DimensionMismatchException(int, int) - Constructor for exception org.apache.commons.math.DimensionMismatchException
Deprecated. Construct an exception from the mismatched dimensions
DimensionMismatchException - Exception in org.apache.commons.math.exception
Exception to be thrown when two dimensions differ.
DimensionMismatchException(int, int) - Constructor for exception org.apache.commons.math.exception.DimensionMismatchException
Construct an exception from the mismatched dimensions.
dimensions() - Method in interface hep.aida.tdouble.DoubleIHistogram
Returns 1 for one-dimensional histograms, 2 for two-dimensional histograms, and so on.
dimensions() - Method in interface hep.aida.tfloat.FloatIHistogram
Returns 1 for one-dimensional histograms, 2 for two-dimensional histograms, and so on.
dirac(double[], double[]) - Static method in class jhplot.math.Random
Generate a random number from a discrete random variable.
DirectSearchOptimizer - Class in org.apache.commons.math.optimization.direct
This class implements simplex-based direct search optimization algorithms.
DirichletDist - Class in umontreal.iro.lecuyer.probdistmulti
Implements the abstract class ContinuousDistributionMulti for the Dirichlet distribution with parameters (α1,...,αd), αi > 0.
DirichletDist(double[]) - Constructor for class umontreal.iro.lecuyer.probdistmulti.DirichletDist
 
DirichletGen - Class in umontreal.iro.lecuyer.randvarmulti
Extends RandomMultivariateGen for a Dirichlet distribution.
DirichletGen(RandomStream, double[]) - Constructor for class umontreal.iro.lecuyer.randvarmulti.DirichletGen
Constructs a new Dirichlet generator with parameters αi+1 = alphas[i], for i = 0,…, k - 1, and the stream stream.
disableAutoCompletion() - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Disables auto completion option.
disableCustomLabels() - Method in class umontreal.iro.lecuyer.charts.Axis
Deprecated. 
disableDoubleBuffering(Component) - Static method in class jhplot.GHPanel
 
disableGrid() - Method in class umontreal.iro.lecuyer.charts.CategoryChart
Disables the background grid.
disableGrid() - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Disables the background grid.
disableGrid() - Method in class umontreal.iro.lecuyer.charts.XYChart
Disables the background grid.
discardFrontElements(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Discards the i initial elements of the array.
discardMostRecentElements(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Discards the i last elements of the array.
DiscreteDistIntChart - Class in umontreal.iro.lecuyer.charts
This class provides tools to plot the mass function and the cumulative probability of a discrete probability distribution over the integers.
DiscreteDistIntChart(DiscreteDistributionInt) - Constructor for class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Constructor for a new DiscreteDistIntChart instance used to plot the probabilities of the discrete distribution dist over the integers.
DiscreteDistIntChart(DiscreteDistributionInt, int, int) - Constructor for class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Constructor for a new DiscreteDistIntChart instance used to plot the probabilities of the discrete distribution dist over the interval [a, b].
DiscreteDistribution - Class in jhplot.math.num.pdf
Base discrete distribution.
DiscreteDistribution() - Constructor for class jhplot.math.num.pdf.DiscreteDistribution
 
DiscreteDistribution - Interface in org.apache.commons.math.distribution
Base interface for discrete distributions.
DiscreteDistribution - Class in umontreal.iro.lecuyer.probdist
Classes implementing discrete distributions over a finite set of real numbers should inherit from this class.
DiscreteDistribution(double[], double[], int) - Constructor for class umontreal.iro.lecuyer.probdist.DiscreteDistribution
Constructs a discrete distribution over the n values contained in array obs, with probabilities given in array prob.
DiscreteDistribution(double[]) - Constructor for class umontreal.iro.lecuyer.probdist.DiscreteDistribution
Constructs a discrete distribution whose parameters are given in a single ordered array: params[0] contains n, the number of values to consider.
DiscreteDistributionInt - Class in umontreal.iro.lecuyer.probdist
Classes implementing discrete distributions over the integers should inherit from this class.
DiscreteDistributionInt() - Constructor for class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
 
DiscreteDistributionIntMulti - Class in umontreal.iro.lecuyer.probdistmulti
Classes implementing multi-dimensional discrete distributions over the integers should inherit from this class.
DiscreteDistributionIntMulti() - Constructor for class umontreal.iro.lecuyer.probdistmulti.DiscreteDistributionIntMulti
 
DiscreteRandomVariable - Interface in jhplot.math.num.random
A random variable generator for a discrete distribution.
disnan(double) - Method in class org.netlib.lapack.LAPACK
..
display() - Method in class cern.colt.Timer
Prints the elapsed time on System.out
displayLimits() - Method in class flanagan.interpolation.BiCubicSpline
 
displayLimits() - Method in class flanagan.interpolation.BiCubicSplineFirstDerivative
 
displayLimits() - Method in class flanagan.interpolation.BiCubicSplinePartialDerivative
 
displayLimits() - Method in class flanagan.interpolation.CubicSpline
 
displayLimits() - Method in class flanagan.interpolation.PolyCubicSpline
 
displayLimits() - Method in class flanagan.interpolation.QuadriCubicSpline
 
displayLimits() - Method in class flanagan.interpolation.TriCubicSpline
 
disposeMe() - Method in class jhplot.GHMargin
Dispose this canvas
distance(DoubleMatrix2D, Statistic.VectorVectorFunction) - Static method in class cern.colt.matrix.doublealgo.Statistic
Constructs and returns the distance matrix of the given matrix.
distance(DoubleMatrix2D, DoubleStatistic.VectorVectorFunction) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Constructs and returns the distance matrix of the given matrix.
distance(FloatMatrix2D, FloatStatistic.VectorVectorFunction) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Constructs and returns the distance matrix of the given matrix.
distance(SpacePoint, SpacePoint) - Static method in class hephysics.vec.SpacePoint
Return the distance between two space points.
distance(DataPoint, DataPoint) - Static method in class jminhep.cluster.DataPoint
Returns the distance between two data points
distance(Rotation, Rotation) - Static method in class org.apache.commons.math.geometry.Rotation
Compute the distance between two rotations.
distance(Vector3D, Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3D
Compute the distance between two vectors according to the L2 norm.
distance(double[], double[]) - Static method in class org.apache.commons.math.util.MathUtils
Calculates the L2 (Euclidean) distance between two points.
distance(int[], int[]) - Static method in class org.apache.commons.math.util.MathUtils
Calculates the L2 (Euclidean) distance between two points.
distance1(Vector3D, Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3D
Compute the distance between two vectors according to the L1 norm.
distance1(double[], double[]) - Static method in class org.apache.commons.math.util.MathUtils
Calculates the L1 (sum of abs) distance between two points.
distance1(int[], int[]) - Static method in class org.apache.commons.math.util.MathUtils
Calculates the L1 (sum of abs) distance between two points.
distanceFrom(T) - Method in interface org.apache.commons.math.stat.clustering.Clusterable
Returns the distance from the given point.
distanceFrom(EuclideanIntegerPoint) - Method in class org.apache.commons.math.stat.clustering.EuclideanIntegerPoint
Returns the distance from the given point.
distanceInf(Vector3D, Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3D
Compute the distance between two vectors according to the L norm.
distanceInf(double[], double[]) - Static method in class org.apache.commons.math.util.MathUtils
Calculates the L (max of abs) distance between two points.
distanceInf(int[], int[]) - Static method in class org.apache.commons.math.util.MathUtils
Calculates the L (max of abs) distance between two points.
distanceSq(Vector3D, Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3D
Compute the square of the distance between two vectors.
distanceSqrt(DataPoint, DataPoint) - Static method in class jminhep.cluster.DataPoint
Returns the squared distance between two data points
DistinctNumberList - Class in cern.colt.list
Resizable compressed list holding numbers; based on the fact that a number from a large list with few distinct values need not take more than log(distinctValues) bits; implemented with a MinMaxNumberList.
DistinctNumberList(long[], int) - Constructor for class cern.colt.list.DistinctNumberList
Constructs an empty list with the specified initial capacity and the specified distinct values allowed to be hold in this list.
DistinctNumberList - Class in cern.colt.list.tlong
Resizable compressed list holding numbers; based on the fact that a number from a large list with few distinct values need not take more than log(distinctValues) bits; implemented with a MinMaxNumberList.
DistinctNumberList(long[], int) - Constructor for class cern.colt.list.tlong.DistinctNumberList
Constructs an empty list with the specified initial capacity and the specified distinct values allowed to be hold in this list.
Distribution - Interface in jhplot.math.num.pdf
Base statistical distribution.
Distribution - Interface in org.apache.commons.math.distribution
Base interface for probability distributions.
Distribution - Interface in umontreal.iro.lecuyer.probdist
This interface should be implemented by all classes supporting discrete and continuous distributions.
DistributionFactory - Class in umontreal.iro.lecuyer.probdist
This class implements a string API for the package probdist.
Distributions - Class in cern.jet.random
Contains methods for conveniently generating pseudo-random numbers from special distributions such as the Burr, Cauchy, Erlang, Geometric, Lambda, Laplace, Logistic, Weibull, etc.
Distributions - Class in cern.jet.random.tdouble
Contains methods for conveniently generating pseudo-random numbers from special distributions such as the Burr, Cauchy, Erlang, Geometric, Lambda, Laplace, Logistic, Weibull, etc.
distroy() - Method in class jhplot.HPlot
Remove the canvas frame
distroy() - Method in class jhplot.HPlot2D
Remove the canvas frame
div(DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A / s <=> A[i] = A[i] / s.
div(DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A / B <=> A[i] = A[i] / B[i].
div(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A / s <=> A[row,col] = A[row,col] / s.
div(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A / B <=> A[row,col] = A[row,col] / B[row,col].
div - Static variable in class cern.jet.math.Functions
Function that returns a / b.
div(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a / b.
div - Static variable in class cern.jet.math.IntFunctions
Function that returns a / b.
div(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a / b.
div(double) - Static method in class cern.jet.math.Mult
a / constant.
div(double[], double, double) - Static method in class cern.jet.math.tdcomplex.DComplex
 
div(double[], double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
div - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
Binary functions
div(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
div(double) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
div(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexMult
a / constant.
div - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a / b.
div(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a / b.
div(double) - Static method in class cern.jet.math.tdouble.DoubleMult
a / constant.
div(float[], float, float) - Static method in class cern.jet.math.tfcomplex.FComplex
 
div(float[], float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
div - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
Binary functions
div(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
div(float) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
div(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexMult
a / constant.
div - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a / b.
div(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a / b.
div(float) - Static method in class cern.jet.math.tfloat.FloatMult
a / constant.
div - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a / b.
div(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a / b.
div(int) - Static method in class cern.jet.math.tint.IntMult
a / constant.
div - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a / b.
div(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a / b.
div(long) - Static method in class cern.jet.math.tlong.LongMult
a / constant.
div(Binner1D, Binner1D, Binner1D) - Static method in class hep.aida.ref.histogram.binner.BinnerMath
 
div(Complex) - Method in class jhplot.math.Complex
Division of Complex numbers (doesn't change this Complex number).
div(float) - Method in class jhplot.v3d.Vector3d
 
divide(String, IDataPointSet, IDataPointSet) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
divide(String, IHistogram1D, IHistogram1D) - Method in class hep.aida.ref.histogram.HistogramFactory
Divides two 1D Histogram
divide(String, IHistogram2D, IHistogram2D) - Method in class hep.aida.ref.histogram.HistogramFactory
Divides two 2D Histogram
divide(String, IHistogram3D, IHistogram3D) - Method in class hep.aida.ref.histogram.HistogramFactory
Divides two 3D Histogram
divide(double) - Method in class jhplot.math.Complex
Returns this complex divided by the specified factor.
divide(double[], double[]) - Static method in class jhplot.math.LinearAlgebra
Element-wise ratio of two arrays.
divide(double[], double) - Static method in class jhplot.math.LinearAlgebra
Divide each element of an array by a scalar.
divide(double[][], double) - Static method in class jhplot.math.LinearAlgebra
Divide each element of a matrix by a scalar
divide(double[][], double[]...) - Static method in class jhplot.math.LinearAlgebra
 
divide(ValueErr, double) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a ValueErr number.
divide(ValueErr, ValueErr, double) - Static method in class jhplot.math.ValueErr
Division of two ValueErr numbers a/b with correlation
divide(ValueErr) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a ValueErr number without correlation
divide(ValueErr, ValueErr) - Static method in class jhplot.math.ValueErr
Division of two ValueErr numbers a/b without correlation
divide(double) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a double
divide(double, ValueErr) - Static method in class jhplot.math.ValueErr
Division of a double, a, by a ValueErr number, b
divide(double, double) - Static method in class jhplot.math.ValueErr
Divide a double number by a double and return quotient as ValueErr
DIVIDE - Static variable in class org.apache.commons.math.analysis.BinaryFunction
Deprecated. The / operator method wrapped as a BinaryFunction.
divide(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.ComposableFunction
Return a function dividing the instance by another function.
divide(Complex) - Method in class org.apache.commons.math.complex.Complex
Return the quotient of this complex number and the given complex number.
divide(Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Divide this by divisor.
divide(int) - Method in class org.apache.commons.math.dfp.Dfp
Divide by a single digit less than radix.
divide(T) - Method in interface org.apache.commons.math.FieldElement
Compute this ÷ a.
divide(BigInteger) - Method in class org.apache.commons.math.fraction.BigFraction
Divide the value of this fraction by the passed BigInteger, ie "this * 1 / bg", returning the result in reduced form.
divide(int) - Method in class org.apache.commons.math.fraction.BigFraction
Divide the value of this fraction by the passed int, ie "this * 1 / i", returning the result in reduced form.
divide(long) - Method in class org.apache.commons.math.fraction.BigFraction
Divide the value of this fraction by the passed long, ie "this * 1 / l", returning the result in reduced form.
divide(BigFraction) - Method in class org.apache.commons.math.fraction.BigFraction
Divide the value of this fraction by another, returning the result in reduced form.
divide(Fraction) - Method in class org.apache.commons.math.fraction.Fraction
Divide the value of this fraction by another.
divide(int) - Method in class org.apache.commons.math.fraction.Fraction
Divide the fraction by an integer.
divide(BigReal) - Method in class org.apache.commons.math.util.BigReal
Compute this ÷ a.
dividedBy(Matrix) - Method in class jhplot.bsom.Matrix
Matrix division: X\Y.
dividedBy(Matrix, int) - Method in class jhplot.bsom.Matrix
Matrix division with bandwidth: X\Y.
DividedDifferenceInterpolator - Class in org.apache.commons.math.analysis.interpolation
Implements the Divided Difference Algorithm for interpolation of real univariate functions.
DividedDifferenceInterpolator() - Constructor for class org.apache.commons.math.analysis.interpolation.DividedDifferenceInterpolator
 
divideEqual(ValueErr) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a ValueErr number and replace it by the quotient without correlation
divideEqual(ValueErr, double) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a ValueErr number and replace this by the quotient
divideEqual(double) - Method in class jhplot.math.ValueErr
Division of this ValueErr number by a double and replace this by the quotient
divideLU(double[][], double[]...) - Static method in class jhplot.math.LinearAlgebra
 
divideQR(double[][], double[]...) - Static method in class jhplot.math.LinearAlgebra
 
divNeg - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns -(a / b).
divNeg - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns -(a / b).
divNeg - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns -(a / b).
divNeg - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns -(a / b).
dlabad(doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlabrd(int, int, int, double[], int, double[], double[], double[], double[], double[], int, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlacn2(int, double[], double[], int[], doubleW, intW, int[]) - Method in class org.netlib.lapack.LAPACK
..
dlacon(int, double[], double[], int[], doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dlacpy(String, int, int, double[], int, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dladiv(double, double, double, double, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlae2(double, double, double, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlaebz(int, int, int, int, int, int, double, double, double, double[], double[], double[], int[], double[], double[], intW, int[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlaed0(int, int, int, double[], double[], double[], int, double[], int, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlaed1(int, double[], double[], int, int[], doubleW, int, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlaed2(intW, int, int, double[], double[], int, int[], doubleW, double[], double[], double[], double[], int[], int[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlaed3(int, int, int, double[], double[], int, double, double[], double[], int[], int[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlaed4(int, int, double[], double[], double[], double, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dlaed5(int, double[], double[], double[], double, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlaed6(int, boolean, double, double[], double[], double, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dlaed7(int, int, int, int, int, int, double[], double[], int, int[], doubleW, int, double[], int[], int[], int[], int[], int[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlaed8(int, intW, int, int, double[], double[], int, int[], doubleW, int, double[], double[], double[], int, double[], int[], intW, int[], double[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlaed9(int, int, int, int, double[], double[], int, double, double[], double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dlaeda(int, int, int, int, int[], int[], int[], int[], double[], double[], int[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlaein(boolean, boolean, int, double[], int, double, double, double[], double[], double[], int, double[], double, double, double, intW) - Method in class org.netlib.lapack.LAPACK
..
dlaev2(double, double, double, doubleW, doubleW, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlaexc(boolean, int, double[], int, double[], int, int, int, int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlag2(double[], int, double[], int, double, doubleW, doubleW, doubleW, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlag2s(int, int, double[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dlags2(boolean, double, double, double, double, double, double, doubleW, doubleW, doubleW, doubleW, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlagtf(int, double[], double, double[], double[], double, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlagtm(String, int, int, double, double[], double[], double[], double[], int, double, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlagts(int, int, double[], double[], double[], double[], int[], double[], doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dlagv2(double[], int, double[], int, double[], double[], double[], doubleW, doubleW, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlahqr(boolean, boolean, int, int, int, double[], int, double[], double[], int, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dlahr2(int, int, int, double[], int, double[], double[], int, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlahrd(int, int, int, double[], int, double[], double[], int, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlaic1(int, int, double[], double, double[], double, doubleW, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlaisnan(double, double) - Method in class org.netlib.lapack.LAPACK
..
dlaln2(boolean, int, int, double, double, double[], int, double, double, double[], int, double, double, double[], int, doubleW, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dlals0(int, int, int, int, int, double[], int, double[], int, int[], int, int[], int, double[], int, double[], double[], double[], double[], int, double, double, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlalsa(int, int, int, int, double[], int, double[], int, double[], int, double[], int[], double[], double[], double[], double[], int[], int[], int, int[], double[], double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlalsd(String, int, int, int, double[], double[], double[], int, double, intW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlamc1(intW, intW, booleanW, booleanW) - Method in class org.netlib.lapack.LAPACK
..
dlamc2(intW, intW, booleanW, doubleW, intW, doubleW, intW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlamc3(double, double) - Method in class org.netlib.lapack.LAPACK
..
dlamc4(intW, double, int) - Method in class org.netlib.lapack.LAPACK
..
dlamc5(int, int, int, boolean, intW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlamch(String) - Method in class org.netlib.lapack.LAPACK
..
dlamrg(int, int, double[], int, int, int[]) - Method in class org.netlib.lapack.LAPACK
..
dlaneg(int, double[], double[], double, double, int) - Method in class org.netlib.lapack.LAPACK
..
dlangb(String, int, int, int, double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlange(String, int, int, double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlangt(String, int, double[], double[], double[]) - Method in class org.netlib.lapack.LAPACK
..
dlanhs(String, int, double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlansb(String, String, int, int, double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlansp(String, String, int, double[], double[]) - Method in class org.netlib.lapack.LAPACK
..
dlanst(String, int, double[], double[]) - Method in class org.netlib.lapack.LAPACK
..
dlansy(String, String, int, double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlantb(String, String, String, int, int, double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlantp(String, String, String, int, double[], double[]) - Method in class org.netlib.lapack.LAPACK
..
dlantr(String, String, String, int, int, double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlanv2(doubleW, doubleW, doubleW, doubleW, doubleW, doubleW, doubleW, doubleW, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlapll(int, double[], int, double[], int, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlapmt(boolean, int, int, double[], int, int[]) - Method in class org.netlib.lapack.LAPACK
..
dlapy2(double, double) - Method in class org.netlib.lapack.LAPACK
..
dlapy3(double, double, double) - Method in class org.netlib.lapack.LAPACK
..
dlaqgb(int, int, int, int, double[], int, double[], double[], double, double, double, StringW) - Method in class org.netlib.lapack.LAPACK
..
dlaqge(int, int, double[], int, double[], double[], double, double, double, StringW) - Method in class org.netlib.lapack.LAPACK
..
dlaqp2(int, int, int, double[], int, int[], double[], double[], double[], double[]) - Method in class org.netlib.lapack.LAPACK
..
dlaqps(int, int, int, int, intW, double[], int, int[], double[], double[], double[], double[], double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlaqr0(boolean, boolean, int, int, int, double[], int, double[], double[], int, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dlaqr1(int, double[], int, double, double, double, double, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlaqr2(boolean, boolean, int, int, int, int, double[], int, int, int, double[], int, intW, intW, double[], double[], double[], int, int, double[], int, int, double[], int, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlaqr3(boolean, boolean, int, int, int, int, double[], int, int, int, double[], int, intW, intW, double[], double[], double[], int, int, double[], int, int, double[], int, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlaqr4(boolean, boolean, int, int, int, double[], int, double[], double[], int, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dlaqr5(boolean, boolean, int, int, int, int, int, double[], double[], double[], int, int, int, double[], int, double[], int, double[], int, int, double[], int, int, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlaqrb(boolean, int, int, int, double[], int, double[], double[], double[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dlaqsb(String, int, int, double[], int, double[], double, double, StringW) - Method in class org.netlib.lapack.LAPACK
..
dlaqsp(String, int, double[], double[], double, double, StringW) - Method in class org.netlib.lapack.LAPACK
..
dlaqsy(String, int, double[], int, double[], double, double, StringW) - Method in class org.netlib.lapack.LAPACK
..
dlaqtr(boolean, boolean, int, double[], int, double[], double, doubleW, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlar1v(int, int, int, double, double[], double[], double[], double[], double, double, double[], boolean, intW, doubleW, doubleW, intW, int[], doubleW, doubleW, doubleW, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlar2v(int, double[], double[], double[], int, double[], double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlarf(String, int, int, double[], int, double, double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlarfb(String, String, String, String, int, int, int, double[], int, double[], int, double[], int, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlarfg(int, doubleW, double[], int, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlarft(String, String, int, int, double[], int, double[], double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlarfx(String, int, int, double[], double, double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlargv(int, double[], int, double[], int, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlarnv(int, int[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlarra(int, double[], double[], double[], double, double, intW, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlarrb(int, double[], double[], int, int, double, double, int, double[], double[], double[], double[], int[], double, double, int, intW) - Method in class org.netlib.lapack.LAPACK
..
dlarrc(String, int, double, double, double[], double[], double, intW, intW, intW, intW) - Method in class org.netlib.lapack.LAPACK
..
dlarrd(String, String, int, double, double, int, int, double[], double, double[], double[], double[], double, int, int[], intW, double[], double[], doubleW, doubleW, int[], int[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlarre(String, int, doubleW, doubleW, int, int, double[], double[], double[], double, double, double, intW, int[], intW, double[], double[], double[], int[], int[], double[], doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlarrf(int, double[], double[], double[], int, int, double[], double[], double[], double, double, double, double, doubleW, double[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlarrj(int, double[], double[], int, int, double, int, double[], double[], double[], int[], double, double, intW) - Method in class org.netlib.lapack.LAPACK
..
dlarrk(int, int, double, double, double[], double[], double, double, doubleW, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dlarrr(int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlarrv(int, double, double, double[], double[], double, int[], int, int, int, double, doubleW, doubleW, double[], double[], double[], int[], int[], double[], double[], int, int[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlartg(double, double, doubleW, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlartv(int, double[], int, double[], int, double[], double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlaruv(int[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlarz(String, int, int, int, double[], int, double, double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlarzb(String, String, String, String, int, int, int, int, double[], int, double[], int, double[], int, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlarzt(String, String, int, int, double[], int, double[], double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlas2(double, double, double, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlascl(String, int, int, double, double, int, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dlasd0(int, int, double[], double[], double[], int, double[], int, int, int[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasd1(int, int, int, double[], doubleW, doubleW, double[], int, double[], int, int[], int[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasd2(int, int, int, intW, double[], double[], double, double, double[], int, double[], int, double[], double[], int, double[], int, int[], int[], int[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasd3(int, int, int, int, double[], double[], int, double[], double[], int, double[], int, double[], int, double[], int, int[], int[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasd4(int, int, double[], double[], double[], double, doubleW, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasd5(int, double[], double[], double[], double, doubleW, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlasd6(int, int, int, int, double[], double[], double[], doubleW, doubleW, int[], int[], intW, int[], int, double[], int, double[], double[], double[], double[], intW, doubleW, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasd7(int, int, int, int, intW, double[], double[], double[], double[], double[], double[], double[], double, double, double[], int[], int[], int[], int[], intW, int[], int, double[], int, doubleW, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dlasd8(int, int, double[], double[], double[], double[], double[], double[], int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasda(int, int, int, int, double[], double[], double[], int, double[], int[], double[], double[], double[], double[], int[], int[], int, int[], double[], double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasdq(String, int, int, int, int, int, double[], double[], double[], int, double[], int, double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasdt(int, intW, intW, int[], int[], int[], int) - Method in class org.netlib.lapack.LAPACK
..
dlaset(String, int, int, double, double, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlasq1(int, double[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasq2(int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlasq3(int, intW, double[], int, doubleW, doubleW, doubleW, doubleW, intW, intW, intW, boolean) - Method in class org.netlib.lapack.LAPACK
..
dlasq4(int, int, double[], int, int, double, double, double, double, double, double, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dlasq5(int, int, double[], int, double, doubleW, doubleW, doubleW, doubleW, doubleW, doubleW, boolean) - Method in class org.netlib.lapack.LAPACK
..
dlasq6(int, int, double[], int, doubleW, doubleW, doubleW, doubleW, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlasr(String, String, String, int, int, double[], double[], double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlasrt(String, int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlassq(int, double[], int, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlasv2(double, double, double, doubleW, doubleW, doubleW, doubleW, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlaswp(int, double[], int, int, int, int[], int) - Method in class org.netlib.lapack.LAPACK
..
dlasy2(boolean, boolean, int, int, int, double[], int, double[], int, double[], int, doubleW, double[], int, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dlasyf(String, int, int, intW, double[], int, int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dlatbs(String, String, String, String, int, int, double[], int, double[], doubleW, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlatdf(int, int, double[], int, double[], doubleW, doubleW, int[], int[]) - Method in class org.netlib.lapack.LAPACK
..
dlatps(String, String, String, String, int, double[], double[], doubleW, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlatrd(String, int, int, double[], int, double[], double[], double[], int) - Method in class org.netlib.lapack.LAPACK
..
dlatrs(String, String, String, String, int, double[], int, double[], doubleW, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dlatrz(int, int, int, double[], int, double[], double[]) - Method in class org.netlib.lapack.LAPACK
..
dlatzm(String, int, int, double[], int, double, double[], double[], int, double[]) - Method in class org.netlib.lapack.LAPACK
..
dlauu2(String, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dlauum(String, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dlazq3(int, intW, double[], int, doubleW, doubleW, doubleW, doubleW, intW, intW, intW, boolean, intW, doubleW, doubleW, doubleW, doubleW, doubleW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
dlazq4(int, int, double[], int, int, double, double, double, double, double, double, doubleW, intW, doubleW) - Method in class org.netlib.lapack.LAPACK
..
DMatrix - Class in umontreal.iro.lecuyer.util
This class implements a few methods for matrix calculations with double numbers.
DMatrix(int, int) - Constructor for class umontreal.iro.lecuyer.util.DMatrix
Creates a new DMatrix with r rows and c columns.
DMatrix(double[][], int, int) - Constructor for class umontreal.iro.lecuyer.util.DMatrix
Creates a new DMatrix with r rows and c columns using the data in data.
DMatrix(DMatrix) - Constructor for class umontreal.iro.lecuyer.util.DMatrix
Copy constructor.
dmout(int, int, int, double[], int, int, String) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dnaitr(intW, String, int, int, int, int, double[], doubleW, double[], int, double[], int, int[], double[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dnapps(int, intW, int, double[], double[], double[], int, double[], int, double[], double[], int, double[], double[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dnaup2(intW, String, int, String, intW, intW, double, double[], int, int, int, intW, double[], int, double[], int, double[], double[], double[], double[], int, double[], int[], double[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dnaupd(intW, String, int, String, int, doubleW, double[], int, double[], int, int[], int[], double[], double[], int, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dnconv(int, double[], double[], double[], double, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dneigh(double, intW, double[], int, double[], double[], double[], double[], int, double[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dneupd(boolean, String, boolean[], double[], double[], double[], int, double, double, double[], String, int, String, intW, double, double[], int, double[], int, int[], int[], double[], double[], int, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dngets(int, String, intW, intW, double[], double[], double[], double[], double[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dnrm2(DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Return the 2-norm; sqrt(x[0]^2 + x[1]^2 + ...).
dnrm2(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dnrm2(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dnrm2(DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Return the 2-norm; sqrt(x[0]^2 + x[1]^2 + ...).
dnrm2(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dnrm2(FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Return the 2-norm; sqrt(x[0]^2 + x[1]^2 + ...).
dnrm2(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dnrm2(int, double[], int) - Method in class org.netlib.blas.BLAS
..
doc() - Method in class jhplot.F1D
Show online documentation.
doc() - Method in class jhplot.F2D
Show online documentation.
doc() - Method in class jhplot.F3D
Show online documentation.
doc() - Method in class jhplot.FND
Show online documentation.
doc() - Method in class jhplot.H1D
Show online documentation.
doc() - Method in class jhplot.H2D
Show online documentation.
doc() - Method in class jhplot.H3D
Show online documentation.
doc() - Method in class jhplot.HBayes
 
doc() - Method in class jhplot.HBook
Show online documentation.
doc() - Method in class jhplot.HBsom
Show documentation
doc() - Method in class jhplot.HCellular
Show documentation
doc() - Method in class jhplot.HChart
Show online documentation.
doc() - Method in class jhplot.HCluster
Show online documentation.
doc() - Method in class jhplot.HFit
Show online documentation.
doc() - Method in class jhplot.HFitter
Show online documentation.
doc() - Method in class jhplot.HGraph
Show online documentation.
doc() - Method in class jhplot.HLabel
Show online documentation.
doc() - Method in class jhplot.HLabelEq
Show online documentation.
doc() - Method in class jhplot.HMLabel
Show online documentation.
doc() - Method in class jhplot.HNeuralNet
Show online documentation.
doc() - Method in class jhplot.HPlot
Show online documentation.
doc() - Method in class jhplot.HPlot2D
Show online documentation.
doc() - Method in class jhplot.HPlot3D
Show online documentation.
doc() - Method in class jhplot.HPlot3DP
Show online documentation.
doc() - Method in class jhplot.HPlotJa
Show online documentation.
doc() - Method in class jhplot.HProf1D
Show online documentation.
doc() - Method in class jhplot.HProf2D
Show online documentation.
doc() - Method in class jhplot.HTable
Show online documentation.
doc() - Method in class jhplot.HView3D
Show online documentation.
doc() - Method in class jhplot.IEditor
Show online documentation.
doc() - Method in class jhplot.io.csv.CSVReader
Show online documentation.
doc() - Method in class jhplot.io.csv.CSVWriter
Show online documentation.
doc() - Method in class jhplot.io.FileAida
Show online documentation.
doc() - Method in class jhplot.io.FileRoot
Show online documentation.
doc() - Method in class jhplot.IView
Show online documentation.
doc() - Method in class jhplot.JHPlot
Show online documentation.
doc() - Method in class jhplot.P0D
Show online documentation.
doc() - Method in class jhplot.P0I
Show online documentation.
doc() - Method in class jhplot.P1D
Show online documentation.
doc() - Method in class jhplot.P2D
Show online documentation.
doc() - Method in class jhplot.P3D
Show online documentation.
doc() - Method in class jhplot.PND
Show online documentation.
doc() - Method in class jhplot.PNI
Show online documentation.
doc() - Method in class jhplot.shapes.Arrow
Show online documentation.
doc() - Method in class jhplot.shapes.Circle
Show online documentation.
doc() - Method in class jhplot.shapes.Ellipse
Show online documentation.
doc() - Method in class jhplot.shapes.Line
Show online documentation.
doc() - Method in class jhplot.shapes.Picture
Show online documentation.
doc() - Method in class jhplot.shapes.Rectan
Show online documentation.
doc() - Method in class jhplot.shapes.Text
Show online documentation.
doc() - Method in class jhplot.SHPlot
Show online documentation.
doc() - Method in class jhplot.SHPlot3D
Show online documentation.
doc() - Method in class jhplot.SHPlotJa
Show online documentation.
doc() - Method in class jhplot.SPlot
Show online documentation.
doc() - Method in class jhplot.SPsheet
Show online documentation.
doc() - Method in class jhplot.stat.BunchingParameters
Show online documentation.
doc() - Method in class jhplot.stat.FactorialMoments
Show online documentation.
doc() - Method in class jhplot.stat.LinReg
Show online documentation.
doc() - Method in class jhplot.stat.LinRegWeighted
Show online documentation.
doc() - Method in class jhplot.stat.PCA
Show online documentation.
doc() - Method in class jhplot.stat.Statistics
Show online documentation.
doc() - Method in class jhplot.stat.StatShape
Show online documentation.
doc() - Method in class jhplot.VHolder
Show online documentation.
doc() - Method in class jhpro.stat.CLimits
Show online documentation.
doc() - Method in class jhpro.stat.ConfidenceLevel
Show online documentation.
doc() - Method in class jhpro.stat.EEcentricity
Show online documentation.
doc() - Method in class jhpro.stat.Moments
Show online documentation.
doc() - Method in class jhpro.stat.MomentsFac
Show online documentation.
doc() - Method in class jhpro.stat.MomentsFacNorm
Show online documentation.
doc() - Method in class jhpro.stat.MomentsNorm
Show online documentation.
doOptimize() - Method in class org.apache.commons.math.optimization.general.GaussNewtonOptimizer
Perform the bulk of optimization algorithm.
doOptimize() - Method in class org.apache.commons.math.optimization.linear.SimplexSolver
Perform the bulk of optimization algorithm.
dopgtr(String, int, double[], double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dopmtr(String, String, String, int, int, double[], double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dorg2l(int, int, int, double[], int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dorg2r(int, int, int, double[], int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dorgbr(String, int, int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dorghr(int, int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dorgl2(int, int, int, double[], int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dorglq(int, int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dorgql(int, int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dorgqr(int, int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dorgr2(int, int, int, double[], int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dorgrq(int, int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dorgtr(String, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dorm2l(String, String, int, int, int, double[], int, double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dorm2r(String, String, int, int, int, double[], int, double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
DormandPrince54Integrator - Class in org.apache.commons.math.ode.nonstiff
This class implements the 5(4) Dormand-Prince integrator for Ordinary Differential Equations.
DormandPrince54Integrator(double, double, double, double) - Constructor for class org.apache.commons.math.ode.nonstiff.DormandPrince54Integrator
Simple constructor.
DormandPrince54Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.nonstiff.DormandPrince54Integrator
Simple constructor.
DormandPrince853Integrator - Class in org.apache.commons.math.ode.nonstiff
This class implements the 8(5,3) Dormand-Prince integrator for Ordinary Differential Equations.
DormandPrince853Integrator(double, double, double, double) - Constructor for class org.apache.commons.math.ode.nonstiff.DormandPrince853Integrator
Simple constructor.
DormandPrince853Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.nonstiff.DormandPrince853Integrator
Simple constructor.
dormbr(String, String, String, int, int, int, double[], int, double[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dormhr(String, String, int, int, int, int, double[], int, double[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dorml2(String, String, int, int, int, double[], int, double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dormlq(String, String, int, int, int, double[], int, double[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dormql(String, String, int, int, int, double[], int, double[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dormqr(String, String, int, int, int, double[], int, double[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dormr2(String, String, int, int, int, double[], int, double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dormr3(String, String, int, int, int, int, double[], int, double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dormrq(String, String, int, int, int, double[], int, double[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dormrz(String, String, int, int, int, int, double[], int, double[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dormtr(String, String, String, int, int, double[], int, double[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dot(Hep3Vector, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Dot product of 2 vectors
dot(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Dot operation
dot(HepLorentzVector, HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Dot product
dot(Hep3Vector, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
dot(Vector3d) - Method in class jhplot.v3d.Vector3d
 
dotProduct(Vector3D, Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3D
Compute the dot-product of two vectors.
dotProduct(double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Compute the dot product.
dotProduct(RealVector) - Method in class org.apache.commons.math.linear.AbstractRealVector
Compute the dot product.
dotProduct(FieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute the dot product.
dotProduct(T[]) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute the dot product.
dotProduct(ArrayFieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute the dot product.
dotProduct(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Compute the dot product.
dotProduct(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Compute the dot product.
dotProduct(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Compute the dot product.
dotProduct(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldVector
Compute the dot product.
dotProduct(T[]) - Method in interface org.apache.commons.math.linear.FieldVector
Compute the dot product.
dotProduct(OpenMapRealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Optimized method to compute the dot product with an OpenMapRealVector.
dotProduct(RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Compute the dot product.
dotProduct(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Compute the dot product.
dotProduct(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Compute the dot product.
dotProduct(FieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Compute the dot product.
dotProduct(T[]) - Method in class org.apache.commons.math.linear.SparseFieldVector
Compute the dot product.
dotrap(int, String, Dfp, Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Raises a trap.
Double27Function - Interface in cern.colt.function
Interface that represents a function object: a function that takes 27 arguments and returns a single value.
Double27Function - Interface in cern.colt.function.tdouble
Interface that represents a function object: a function that takes 27 arguments and returns a single value.
Double5Function - Interface in cern.colt.function
Interface that represents a function object: a function that takes 5 arguments and returns a single value.
Double5Function - Interface in cern.colt.function.tdouble
Interface that represents a function object: a function that takes 5 arguments and returns a single value.
Double9Function - Interface in cern.colt.function
Interface that represents a function object: a function that takes 9 arguments and returns a single value.
Double9Function - Interface in cern.colt.function.tdouble
Interface that represents a function object: a function that takes 9 arguments and returns a single value.
DoubleAMG - Class in cern.colt.matrix.tdouble.algo.solver.preconditioner
Algebraic multigrid preconditioner.
DoubleAMG(double, double, double, double, int, int, int, int, double) - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleAMG
Sets up the algebraic multigrid preconditioner
DoubleAMG(double, double, int, int, int, int, double) - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleAMG
Sets up the algebraic multigrid preconditioner.
DoubleAMG() - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleAMG
Sets up the algebraic multigrid preconditioner using some default parameters.
DoubleArithmetic - Class in cern.jet.math.tdouble
Arithmetic functions.
doubleArray(int) - Method in class flanagan.math.PsRandom
 
doubleArray(int, double) - Method in class flanagan.math.PsRandom
 
doubleArray(int, double, double) - Method in class flanagan.math.PsRandom
 
DoubleArray - Class in jhplot.math
A class for dealing with double arrays and matrices.
DoubleArray() - Constructor for class jhplot.math.DoubleArray
 
DoubleArray - Class in jhplot.math.num
An expandable double array.
DoubleArray() - Constructor for class jhplot.math.num.DoubleArray
 
DoubleArray - Interface in org.apache.commons.math.util
Provides a standard interface for double arrays.
DoubleArrayComparator - Class in umontreal.iro.lecuyer.util
An implementation of Comparator which compares two double arrays by comparing their i-th element, where i is given in the constructor.
DoubleArrayComparator(int) - Constructor for class umontreal.iro.lecuyer.util.DoubleArrayComparator
Constructs a comparator, where i is the index used for the comparisons.
DoubleArrayList - Class in cern.colt.list
Resizable list holding double elements; implemented with arrays.
DoubleArrayList() - Constructor for class cern.colt.list.DoubleArrayList
Constructs an empty list.
DoubleArrayList(double[]) - Constructor for class cern.colt.list.DoubleArrayList
Constructs a list containing the specified elements.
DoubleArrayList(int) - Constructor for class cern.colt.list.DoubleArrayList
Constructs an empty list with the specified initial capacity.
DoubleArrayList - Class in cern.colt.list.tdouble
Resizable list holding double elements; implemented with arrays.
DoubleArrayList() - Constructor for class cern.colt.list.tdouble.DoubleArrayList
Constructs an empty list.
DoubleArrayList(double[]) - Constructor for class cern.colt.list.tdouble.DoubleArrayList
Constructs a list containing the specified elements.
DoubleArrayList(int) - Constructor for class cern.colt.list.tdouble.DoubleArrayList
Constructs an empty list with the specified initial capacity.
DoubleBiCG - Class in cern.colt.matrix.tdouble.algo.solver
BiCG solver.
DoubleBiCG(DoubleMatrix1D) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleBiCG
Constructor for BiCG.
DoubleBiCGstab - Class in cern.colt.matrix.tdouble.algo.solver
BiCG stablized solver.
DoubleBiCGstab(DoubleMatrix1D) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleBiCGstab
Constructor for BiCGstab.
DoubleBinBinFunction1D - Interface in hep.aida.tdouble.bin
Interface that represents a function object: a function that takes two bins as arguments and returns a single value.
DoubleBinFunction1D - Interface in hep.aida.tdouble.bin
Interface that represents a function object: a function that takes two bins as arguments and returns a single value.
DoubleBinFunctions1D - Class in hep.aida.tdouble.bin
Function objects computing dynamic bin aggregations; to be passed to generic methods.
DoubleBlas - Interface in cern.colt.matrix.tdouble.algo
Subset of the BLAS (Basic Linear Algebra System); High quality "building block" routines for performing basic vector and matrix operations.
DoubleBuffer - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target DoubleBufferConsumer to which data is automatically flushed upon buffer overflow.
DoubleBuffer(DoubleBufferConsumer, int) - Constructor for class cern.colt.buffer.DoubleBuffer
Constructs and returns a new buffer with the given target.
DoubleBuffer - Class in cern.colt.buffer.tdouble
Fixed sized (non resizable) streaming buffer connected to a target DoubleBufferConsumer to which data is automatically flushed upon buffer overflow.
DoubleBuffer(DoubleBufferConsumer, int) - Constructor for class cern.colt.buffer.tdouble.DoubleBuffer
Constructs and returns a new buffer with the given target.
DoubleBuffer - Class in cern.jet.stat.tdouble.quantile
A buffer holding double elements; internally used for computing approximate quantiles.
DoubleBuffer(int) - Constructor for class cern.jet.stat.tdouble.quantile.DoubleBuffer
This method was created in VisualAge.
DoubleBuffer2D - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target DoubleBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
DoubleBuffer2D(DoubleBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.DoubleBuffer2D
Constructs and returns a new buffer with the given target.
DoubleBuffer2D - Class in cern.colt.buffer.tdouble
Fixed sized (non resizable) streaming buffer connected to a target DoubleBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
DoubleBuffer2D(DoubleBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.tdouble.DoubleBuffer2D
Constructs and returns a new buffer with the given target.
DoubleBuffer2DConsumer - Interface in cern.colt.buffer
Target of a streaming DoubleBuffer2D into which data is flushed upon buffer overflow.
DoubleBuffer2DConsumer - Interface in cern.colt.buffer.tdouble
Target of a streaming DoubleBuffer2D into which data is flushed upon buffer overflow.
DoubleBuffer3D - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target DoubleBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
DoubleBuffer3D(DoubleBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.DoubleBuffer3D
Constructs and returns a new buffer with the given target.
DoubleBuffer3D - Class in cern.colt.buffer.tdouble
Fixed sized (non resizable) streaming buffer connected to a target DoubleBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
DoubleBuffer3D(DoubleBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.tdouble.DoubleBuffer3D
Constructs and returns a new buffer with the given target.
DoubleBuffer3DConsumer - Interface in cern.colt.buffer
Target of a streaming DoubleBuffer3D into which data is flushed upon buffer overflow.
DoubleBuffer3DConsumer - Interface in cern.colt.buffer.tdouble
Target of a streaming DoubleBuffer3D into which data is flushed upon buffer overflow.
DoubleBufferConsumer - Interface in cern.colt.buffer
Target of a streaming DoubleBuffer into which data is flushed upon buffer overflow.
DoubleBufferConsumer - Interface in cern.colt.buffer.tdouble
Target of a streaming DoubleBuffer into which data is flushed upon buffer overflow.
DoubleCG - Class in cern.colt.matrix.tdouble.algo.solver
Conjugate Gradients solver.
DoubleCG(DoubleMatrix1D) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleCG
Constructor for CG.
DoubleCGLS - Class in cern.colt.matrix.tdouble.algo.solver
CGLS is Conjugate Gradient for Least Squares method used for solving large-scale, ill-posed inverse problems of the form: b = A*x + noise.
DoubleCGLS() - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleCGLS
 
DoubleCGS - Class in cern.colt.matrix.tdouble.algo.solver
Conjugate Gradients squared solver.
DoubleCGS(DoubleMatrix1D) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleCGS
Constructor for CGS.
DoubleChebyshev - Class in cern.colt.matrix.tdouble.algo.solver
Chebyshev solver.
DoubleChebyshev(DoubleMatrix1D, double, double) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleChebyshev
Constructor for Chebyshev.
DoubleComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
DoubleComparator - Interface in cern.colt.function.tdouble
A comparison function which imposes a total ordering on some collection of elements.
DoubleConstants - Class in cern.jet.math.tdouble
Defines some useful constants.
DoubleConverter - Class in hep.aida.tdouble.ref
Histogram conversions, for example to String and XML format; This class requires the Colt distribution, whereas the rest of the package is entirelly stand-alone.
DoubleConverter() - Constructor for class hep.aida.tdouble.ref.DoubleConverter
Creates a new histogram converter.
DoubleDescriptive - Class in cern.jet.stat.tdouble
Basic descriptive statistics.
DoubleDiagonal - Class in cern.colt.matrix.tdouble.algo.solver.preconditioner
Diagonal preconditioner.
DoubleDiagonal(int) - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleDiagonal
Constructor for DiagonalPreconditioner
DoubleDoubleFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes two arguments and returns a single value.
DoubleDoubleFunction - Interface in cern.colt.function.tdouble
Interface that represents a function object: a function that takes two arguments and returns a single value.
DoubleDoubleProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
DoubleDoubleProcedure - Interface in cern.colt.function.tdouble
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
DoubleEquiDepthHistogram - Class in cern.jet.stat.tdouble.quantile
Read-only equi-depth histogram for selectivity estimation.
DoubleEquiDepthHistogram(double[]) - Constructor for class cern.jet.stat.tdouble.quantile.DoubleEquiDepthHistogram
Constructs an equi-depth histogram with the given quantile elements.
DoubleFactory1D - Class in cern.colt.matrix
Factory for convenient construction of 1-d matrices holding double cells.
DoubleFactory1D - Class in cern.colt.matrix.tdouble
Factory for convenient construction of 1-d matrices holding double cells.
DoubleFactory2D - Class in cern.colt.matrix
Factory for convenient construction of 2-d matrices holding double cells.
DoubleFactory2D - Class in cern.colt.matrix.tdouble
Factory for convenient construction of 2-d matrices holding double cells.
DoubleFactory3D - Class in cern.colt.matrix
Factory for convenient construction of 3-d matrices holding double cells.
DoubleFactory3D - Class in cern.colt.matrix.tdouble
Factory for convenient construction of 3-d matrices holding double cells.
DoubleFixedAxis - Class in hep.aida.tdouble.ref
Fixed-width axis; A reference implementation of hep.aida.IAxis.
DoubleFixedAxis(int, double, double) - Constructor for class hep.aida.tdouble.ref.DoubleFixedAxis
Create an Axis
DoubleFormatter - Class in cern.colt.matrix.tdouble.algo
Flexible, well human readable matrix print formatting; By default decimal point aligned.
DoubleFormatter() - Constructor for class cern.colt.matrix.tdouble.algo.DoubleFormatter
Constructs and returns a matrix formatter with format "%G".
DoubleFormatter(String) - Constructor for class cern.colt.matrix.tdouble.algo.DoubleFormatter
Constructs and returns a matrix formatter.
DoubleFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes a single argument and returns a single value.
DoubleFunction - Interface in cern.colt.function.tdouble
Interface that represents a function object: a function that takes a single argument and returns a single value.
DoubleFunctions - Class in cern.jet.math.tdouble
Function objects to be passed to generic methods.
DoubleGivensRotation - Class in cern.colt.matrix.tdouble.algo.solver
Givens plane rotation
DoubleGivensRotation(double, double) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleGivensRotation
Constructs a Givens plane rotation for a given 2-vector
DoubleGMRES - Class in cern.colt.matrix.tdouble.algo.solver
GMRES solver.
DoubleGMRES(DoubleMatrix1D) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleGMRES
Constructor for GMRES.
DoubleGMRES(DoubleMatrix1D, int) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleGMRES
Constructor for GMRES.
DoubleHistogram1D - Class in hep.aida.tdouble.ref
A reference implementation of hep.aida.IHistogram1D.
DoubleHistogram1D(String, double[]) - Constructor for class hep.aida.tdouble.ref.DoubleHistogram1D
Creates a variable-width histogram.
DoubleHistogram1D(String, DoubleIAxis) - Constructor for class hep.aida.tdouble.ref.DoubleHistogram1D
Creates a histogram with the given axis binning.
DoubleHistogram1D(String, int, double, double) - Constructor for class hep.aida.tdouble.ref.DoubleHistogram1D
Creates a fixed-width histogram.
DoubleHistogram1DContents - Class in hep.aida.tdouble.ref
 
DoubleHistogram1DContents(int[], double[], double[], int, double, double, double, double) - Constructor for class hep.aida.tdouble.ref.DoubleHistogram1DContents
 
DoubleHistogram2D - Class in hep.aida.tdouble.ref
A reference implementation of hep.aida.IHistogram2D.
DoubleHistogram2D(String, double[], double[]) - Constructor for class hep.aida.tdouble.ref.DoubleHistogram2D
Creates a variable-width histogram.
DoubleHistogram2D(String, int, double, double, int, double, double) - Constructor for class hep.aida.tdouble.ref.DoubleHistogram2D
Creates a fixed-width histogram.
DoubleHistogram2D(String, DoubleIAxis, DoubleIAxis) - Constructor for class hep.aida.tdouble.ref.DoubleHistogram2D
Creates a histogram with the given axis binning.
DoubleHistogram3D - Class in hep.aida.tdouble.ref
A reference implementation of hep.aida.IHistogram3D.
DoubleHistogram3D(String, double[], double[], double[]) - Constructor for class hep.aida.tdouble.ref.DoubleHistogram3D
Creates a variable-width histogram.
DoubleHistogram3D(String, int, double, double, int, double, double, int, double, double) - Constructor for class hep.aida.tdouble.ref.DoubleHistogram3D
Creates a fixed-width histogram.
DoubleHistogram3D(String, DoubleIAxis, DoubleIAxis, DoubleIAxis) - Constructor for class hep.aida.tdouble.ref.DoubleHistogram3D
Creates a histogram with the given axis binning.
DoubleHyBR - Class in cern.colt.matrix.tdouble.algo.solver
HyBR is a Hybrid Bidiagonalization Regularization method used for solving large-scale, ill-posed inverse problems of the form: b = A*x + noise The method combines an iterative Lanczos Bidiagonalization (LBD) Method with an SVD-based regularization method to stabilize the semiconvergence behavior that is characteristic of many ill-posed problems.
DoubleHyBR() - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleHyBR
Creates new instance of HyBR solver with default parameters:

innerSolver = HyBR.InnerSolver.TIKHONOV
regularizationMethod = HyBR.RegularizationMethod.ADAPTWGCV
regularizationParameter = 0
omega = 0
reorthogonalize = false
beginRegularization = 2
flatTolerance = 1e-6
computeRnrm = false;
DoubleHyBR(HyBRInnerSolver, HyBRRegularizationMethod, double, double, boolean, int, double, boolean) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleHyBR
Creates new instance of HyBR solver.
DoubleIAxis - Interface in hep.aida.tdouble
An IAxis represents a binned histogram axis.
DoubleICC - Class in cern.colt.matrix.tdouble.algo.solver.preconditioner
Incomplete Cholesky preconditioner without fill-in using a compressed row matrix as internal storage
DoubleICC(int) - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleICC
Sets up the ICC preconditioner
DoubleIdentity - Class in cern.colt.matrix.tdouble.algo.solver.preconditioner
 
DoubleIdentity() - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleIdentity
 
DoubleIHistogram - Interface in hep.aida.tdouble
A common base interface for IHistogram1D, IHistogram2D and IHistogram3D.
DoubleIHistogram1D - Interface in hep.aida.tdouble
A Java interface corresponding to the AIDA 1D Histogram.
DoubleIHistogram2D - Interface in hep.aida.tdouble
A Java interface corresponding to the AIDA 2D Histogram.
DoubleIHistogram3D - Interface in hep.aida.tdouble
A Java interface corresponding to the AIDA 3D Histogram.
DoubleILU - Class in cern.colt.matrix.tdouble.algo.solver.preconditioner
ILU(0) preconditioner using a compressed row matrix as internal storage
DoubleILU(int) - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleILU
Sets up the ILU preconditioner
DoubleILUT - Class in cern.colt.matrix.tdouble.algo.solver.preconditioner
ILU preconditioner with fill-in.
DoubleILUT(int, double, int) - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleILUT
Sets up the preconditioner for the problem size
DoubleILUT(int) - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleILUT
Sets up the preconditioner for the given problem size.
DoubleIntProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
DoubleIntProcedure - Interface in cern.colt.function.tdouble
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
DoubleIR - Class in cern.colt.matrix.tdouble.algo.solver
Iterative Refinement.
DoubleIR(DoubleMatrix1D) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleIR
Constructor for IR.
DoubleIterationMonitor - Interface in cern.colt.matrix.tdouble.algo.solver
Monitors the iterative solution process for convergence and divergence.
DoubleIterationReporter - Interface in cern.colt.matrix.tdouble.algo.solver
Reports on the progress of an iterative solver
DoubleIterativeSolver - Interface in cern.colt.matrix.tdouble.algo.solver
Iterative linear solver.
DoubleListAdapter - Class in cern.colt.list.adapter
Adapter that permits an AbstractDoubleList to be viewed and treated as a JDK 1.2 AbstractList.
DoubleListAdapter(AbstractDoubleList) - Constructor for class cern.colt.list.adapter.DoubleListAdapter
Constructs a list backed by the specified content list.
DoubleListAdapter - Class in cern.colt.list.tdouble
Adapter that permits an AbstractDoubleList to be viewed and treated as a JDK 1.2 AbstractList.
DoubleListAdapter(AbstractDoubleList) - Constructor for class cern.colt.list.tdouble.DoubleListAdapter
Constructs a list backed by the specified content list.
DoubleLongProcedure - Interface in cern.colt.function.tdouble
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
DoubleMatrix1D - Class in cern.colt.matrix
Abstract base class for 1-d matrices (aka vectors) holding double elements.
DoubleMatrix1D - Class in cern.colt.matrix.tdouble
Abstract base class for 1-d matrices (aka vectors) holding double elements.
DoubleMatrix1DComparator - Interface in cern.colt.matrix.doublealgo
A comparison function which imposes a total ordering on some collection of elements.
DoubleMatrix1DComparator - Interface in cern.colt.matrix.tdouble.algo
A comparison function which imposes a total ordering on some collection of elements.
DoubleMatrix1DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DoubleMatrix1DProcedure - Interface in cern.colt.matrix.tdouble
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DoubleMatrix2D - Class in cern.colt.matrix
Abstract base class for 2-d matrices holding double elements.
DoubleMatrix2D - Class in cern.colt.matrix.tdouble
Abstract base class for 2-d matrices holding double elements.
DoubleMatrix2DComparator - Interface in cern.colt.matrix.doublealgo
A comparison function which imposes a total ordering on some collection of elements.
DoubleMatrix2DComparator - Interface in cern.colt.matrix.tdouble.algo
A comparison function which imposes a total ordering on some collection of elements.
DoubleMatrix2DMatrix2DFunction - Interface in cern.colt.matrix.tdouble.algo
Interface that represents a function object: a function that takes two arguments and returns a single value.
DoubleMatrix2DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DoubleMatrix2DProcedure - Interface in cern.colt.matrix.tdouble
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DoubleMatrix3D - Class in cern.colt.matrix
Abstract base class for 3-d matrices holding double elements.
DoubleMatrix3D - Class in cern.colt.matrix.tdouble
Abstract base class for 3-d matrices holding double elements.
DoubleMatrix3DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DoubleMatrix3DProcedure - Interface in cern.colt.matrix.tdouble
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
DoubleMersenneTwister - Class in cern.jet.random.tdouble.engine
MersenneTwister (MT19937) is one of the strongest uniform pseudo-random number generators known so far; at the same time it is quick.
DoubleMersenneTwister() - Constructor for class cern.jet.random.tdouble.engine.DoubleMersenneTwister
Constructs and returns a random number generator with a default seed, which is a constant.
DoubleMersenneTwister(int) - Constructor for class cern.jet.random.tdouble.engine.DoubleMersenneTwister
Constructs and returns a random number generator with the given seed.
DoubleMersenneTwister(Date) - Constructor for class cern.jet.random.tdouble.engine.DoubleMersenneTwister
Constructs and returns a random number generator seeded with the given date.
DoubleMRNSD - Class in cern.colt.matrix.tdouble.algo.solver
MRNSD is Modified Residual Norm Steepest Descent method used for solving large-scale, ill-posed inverse problems of the form: b = A*x + noise.
DoubleMRNSD() - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleMRNSD
 
DoubleMult - Class in cern.jet.math.tdouble
Only for performance tuning of compute intensive linear algebraic computations.
DoubleNotConvergedException - Exception in cern.colt.matrix.tdouble.algo.solver
Signals lack of convergence of an iterative process
DoubleNotConvergedException(DoubleNotConvergedException.Reason, String) - Constructor for exception cern.colt.matrix.tdouble.algo.solver.DoubleNotConvergedException
Constructor for NotConvergedException
DoubleNotConvergedException(DoubleNotConvergedException.Reason) - Constructor for exception cern.colt.matrix.tdouble.algo.solver.DoubleNotConvergedException
Constructor for NotConvergedException.
DoubleNotConvergedException.Reason - Enum in cern.colt.matrix.tdouble.algo.solver
Possible reasons for lack of convergence
DoublePartitioning - Class in cern.colt.matrix.tdouble.algo
Given some interval boundaries, partitions matrices such that cell values falling into an interval are placed next to each other.
DoublePlusMultFirst - Class in cern.jet.math.tdouble
Only for performance tuning of compute intensive linear algebraic computations.
DoublePlusMultSecond - Class in cern.jet.math.tdouble
Only for performance tuning of compute intensive linear algebraic computations.
DoublePreconditioner - Interface in cern.colt.matrix.tdouble.algo.solver.preconditioner
Preconditioner interface.
DoubleProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
DoubleProcedure - Interface in cern.colt.function.tdouble
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
DoubleProperty - Class in cern.colt.matrix.tdouble.algo
Tests matrices for linear algebraic properties (equality, tridiagonality, symmetry, singularity, etc).
DoubleProperty(double) - Constructor for class cern.colt.matrix.tdouble.algo.DoubleProperty
Constructs an instance with a tolerance of Math.abs(newTolerance).
DoubleQMR - Class in cern.colt.matrix.tdouble.algo.solver
Quasi-Minimal Residual method.
DoubleQMR(DoubleMatrix1D) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleQMR
Constructor for QMR.
DoubleQMR(DoubleMatrix1D, DoublePreconditioner, DoublePreconditioner) - Constructor for class cern.colt.matrix.tdouble.algo.solver.DoubleQMR
Constructor for QMR.
DoubleQuantileFinder - Interface in cern.jet.stat.quantile
The interface shared by all quantile finders, no matter if they are exact or approximate.
DoubleQuantileFinder - Interface in cern.jet.stat.tdouble.quantile
The interface shared by all quantile finders, no matter if they are exact or approximate.
DoubleQuantileFinderFactory - Class in cern.jet.stat.tdouble.quantile
Factory constructing exact and approximate quantile finders for both known and unknown N.
DoubleRandomEngine - Class in cern.jet.random.tdouble.engine
Abstract base class for uniform pseudo-random number generating engines.
DoubleRandomSampler - Class in cern.jet.random.tdouble.sampling
Space and time efficiently computes a sorted Simple Random Sample Without Replacement (SRSWOR), that is, a sorted set of n random numbers from an interval of N numbers; Example: Computing n=3 random numbers from the interval [1,50] may yield the sorted random set (7,13,47).
DoubleRandomSampler(long, long, long, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.sampling.DoubleRandomSampler
Constructs a random sampler that computes and delivers sorted random sets in blocks.
DoubleRandomSamplingAssistant - Class in cern.jet.random.tdouble.sampling
Conveniently computes a stable Simple Random Sample Without Replacement (SRSWOR) subsequence of n elements from a given input sequence of N elements; Example: Computing a sublist of n=3 random elements from a list (1,...,50) may yield the sublist (7,13,47).
DoubleRandomSamplingAssistant(long, long, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.sampling.DoubleRandomSamplingAssistant
Constructs a random sampler that samples n random elements from an input sequence of N elements.
DoubleSorting - Class in cern.colt.matrix.tdouble.algo
Matrix quicksorts and mergesorts.
DoubleSSOR - Class in cern.colt.matrix.tdouble.algo.solver.preconditioner
SSOR preconditioner.
DoubleSSOR(int, boolean, double, double) - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleSSOR
Constructor for SSOR
DoubleSSOR(int) - Constructor for class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleSSOR
Constructor for SSOR.
DoubleStatistic - Class in cern.colt.matrix.tdouble.algo
Basic statistics operations on matrices.
DoubleStatistic.VectorVectorFunction - Interface in cern.colt.matrix.tdouble.algo
Interface that represents a function object: a function that takes two argument vectors and returns a single value.
DoubleStencil - Class in cern.colt.matrix.tdouble.algo
Stencil operations.
doubleTOint(double[]) - Static method in class flanagan.math.Fmath
 
DoubleUniform - Class in cern.jet.random.tdouble
Uniform distribution; Math definition and animated definition.
DoubleUniform(double, double, int) - Constructor for class cern.jet.random.tdouble.DoubleUniform
Constructs a uniform distribution with the given minimum and maximum, using a DoubleMersenneTwister seeded with the given seed.
DoubleUniform(double, double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.DoubleUniform
Constructs a uniform distribution with the given minimum and maximum.
DoubleUniform(DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.DoubleUniform
Constructs a uniform distribution with min=0.0 and max=1.0.
doubleValue() - Method in class org.apache.commons.math.fraction.BigFraction
Gets the fraction as a double.
doubleValue() - Method in class org.apache.commons.math.fraction.Fraction
Gets the fraction as a double.
doubleValue() - Method in class org.apache.commons.math.util.BigReal
Get the double value corresponding to the instance.
DoubleVariableAxis - Class in hep.aida.tdouble.ref
Variable-width axis; A reference implementation of hep.aida.IAxis.
DoubleVariableAxis(double[]) - Constructor for class hep.aida.tdouble.ref.DoubleVariableAxis
Constructs and returns an axis with the given bin edges.
DoublyLinked - Class in umontreal.iro.lecuyer.simevents.eventlist
An implementation of EventList using a doubly linked linear list.
DoublyLinked() - Constructor for class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
DOWNSIDE_VARIANCE - Static variable in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
The DOWNSIDE Direction is used to specify that the observations below the cutoff point will be used to calculate SemiVariance
dpbcon(String, int, int, double[], int, double, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpbequ(String, int, int, double[], int, double[], doubleW, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dpbrfs(String, int, int, int, double[], int, double[], int, double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpbstf(String, int, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dpbsv(String, int, int, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dpbsvx(String, String, int, int, int, double[], int, double[], int, StringW, double[], double[], int, double[], int, doubleW, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpbtf2(String, int, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dpbtrf(String, int, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dpbtrs(String, int, int, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dpocon(String, int, double[], int, double, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpoequ(int, double[], int, double[], doubleW, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dporfs(String, int, int, double[], int, double[], int, double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dposv(String, int, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dposvx(String, String, int, int, double[], int, double[], int, StringW, double[], double[], int, double[], int, doubleW, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpotf2(String, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dpotrf(String, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dpotri(String, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dpotrs(String, int, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dppcon(String, int, double[], double, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dppequ(String, int, double[], double[], doubleW, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dpprfs(String, int, int, double[], double[], double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dppsv(String, int, int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dppsvx(String, String, int, int, double[], double[], StringW, double[], double[], int, double[], int, doubleW, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpptrf(String, int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpptri(String, int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpptrs(String, int, int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dptcon(int, double[], double[], double, doubleW, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpteqr(String, int, double[], double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dptrfs(int, int, double[], double[], double[], double[], double[], int, double[], int, double[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dptsv(int, int, double[], double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dptsvx(String, int, int, double[], double[], double[], double[], double[], int, double[], int, doubleW, double[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpttrf(int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dpttrs(int, int, double[], double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dptts2(int, int, double[], double[], double[], int) - Method in class org.netlib.lapack.LAPACK
..
DRand - Class in cern.jet.random.engine
Quick medium quality uniform pseudo-random number generator.
DRand() - Constructor for class cern.jet.random.engine.DRand
Constructs and returns a random number generator with a default seed, which is a constant.
DRand(int) - Constructor for class cern.jet.random.engine.DRand
Constructs and returns a random number generator with the given seed.
DRand(Date) - Constructor for class cern.jet.random.engine.DRand
Constructs and returns a random number generator seeded with the given date.
DRand - Class in cern.jet.random.tdouble.engine
Quick medium quality uniform pseudo-random number generator.
DRand() - Constructor for class cern.jet.random.tdouble.engine.DRand
Constructs and returns a random number generator with a default seed, which is a constant.
DRand(int) - Constructor for class cern.jet.random.tdouble.engine.DRand
Constructs and returns a random number generator with the given seed.
DRand(Date) - Constructor for class cern.jet.random.tdouble.engine.DRand
Constructs and returns a random number generator seeded with the given date.
draw(P1D) - Method in class jhplot.HChart
Draw data from a P1D.
draw(HLabel) - Method in class jhplot.HPlot
Draw a label.
draw(HKey) - Method in class jhplot.HPlot
Draw a key.
draw(HLabelEq) - Method in class jhplot.HPlot
Draw a LaTeX rquation on the Canvas.
draw(HShape) - Method in class jhplot.HPlot
Draw a shape primitive to the Canvas.
draw(HMLabel) - Method in class jhplot.HPlot
Draw a multiline label.
draw(H1D[]) - Method in class jhplot.HPlot
Draw array of histograms
draw(Cloud1D) - Method in class jhplot.HPlot
Plot cloud in 1D.
draw(DataPointSet) - Method in class jhplot.HPlot
Plot Aida datapointset.
draw(Cloud2D) - Method in class jhplot.HPlot
Plot cloud 2D
draw(Histogram1D) - Method in class jhplot.HPlot
Draw 1D histogram
draw(H1D) - Method in class jhplot.HPlot
Plot 1D histogram.
draw(F1D[]) - Method in class jhplot.HPlot
Draw array of F1D holders
draw(DataArray, int) - Method in class jhplot.HPlot
Draw input data represented by DataArray
draw(F1D) - Method in class jhplot.HPlot
Draw an one-dimensional function.
draw(FND) - Method in class jhplot.HPlot
Draw an one-dimensional function from FND
draw(F1D, boolean) - Method in class jhplot.HPlot
Draw an one-dimensional function.
draw(FND, boolean) - Method in class jhplot.HPlot
Draw an one-dimensional function from FND.
draw(P1D[]) - Method in class jhplot.HPlot
Draw array of P1D holders
draw(P1D) - Method in class jhplot.HPlot
Draw data in form of P1D
draw(Cloud2D) - Method in class jhplot.HPlot2D
Plot cloud 2D.
draw(Histogram2D) - Method in class jhplot.HPlot2D
Draw 2D histogram
draw(H2D) - Method in class jhplot.HPlot2D
Draw 2D histogram using a style (see setStyle())
draw(P1D) - Method in class jhplot.HPlot2D
Plot P1D data (x-y) as density plot
draw(F2D) - Method in class jhplot.HPlot2D
Plot F2D function (x-y) as density plot
draw(H2D) - Method in class jhplot.HPlot3D
Draw H2D histogram
draw(P2D) - Method in class jhplot.HPlot3D
Display P2D data holder with X,Y,Z values in 3D.
draw(P3D) - Method in class jhplot.HPlot3D
Display P3D data holder with X,Y,Z values in 3D as surface.
draw(H2D, H2D) - Method in class jhplot.HPlot3D
Plot two H2D histograms on the same plot.
draw(F2D) - Method in class jhplot.HPlot3D
Draw F2D function as a surface.
draw(F2D, F2D) - Method in class jhplot.HPlot3D
Draw two F2D functions on the same plot.
draw(H2D, F2D) - Method in class jhplot.HPlot3D
Draw H2D histogram and F2D function on the same plot.
draw(F2D, H2D) - Method in class jhplot.HPlot3D
Draw F2D and H2D on the same plot.
draw(FPR) - Method in class jhplot.HPlot3DP
Draw a parametric function
draw(H1D, int, int) - Method in class jhplot.HPlotJa
Draw H1D histogram on pad X and pad Y
draw(H2D, int, int) - Method in class jhplot.HPlotJa
Draw 2D histogram on pads given by X and Y.
draw(JaObject) - Method in class jhplot.HPlotJa
Draw JaObject.
draw(P1D) - Method in class jhplot.HPlotJa
Draw H2D histogram on the current pad.
draw(H2D) - Method in class jhplot.HPlotJa
Draw H2D histogram on the current pad.
draw(H1D) - Method in class jhplot.HPlotJa
Draw H1D histogram on the current pad.
draw(F1D[]) - Method in class jhplot.HPlotJa
Draw array of F1D holders
draw(Cloud1D) - Method in class jhplot.HPlotJa
Plot cloud in 1D.
draw(Cloud2D) - Method in class jhplot.HPlotJa
Plot cloud 2D
draw(Histogram1D) - Method in class jhplot.HPlotJa
Draw 1D histogram
draw(DataArray, String) - Method in class jhplot.HPlotJa
Draw data represented by DataArray on the current pad.
draw(F1D, int, int) - Method in class jhplot.HPlotJa
Draw an one-dimensional function on the current pad.
draw(FND, int, int) - Method in class jhplot.HPlotJa
Draw an one-dimensional function on the current pad.
draw(F1D) - Method in class jhplot.HPlotJa
Draw an one-dimensional function on the current pad.
draw(FND) - Method in class jhplot.HPlotJa
Draw an one-dimensional function on the current pad.
draw(P1D, int, int) - Method in class jhplot.HPlotJa
Draw P1D object on the pad
draw(P1D[]) - Method in class jhplot.HPlotJa
Draw array of P1D holders
draw(Object3d) - Method in class jhplot.HView3D
Draw an object.
draw(ConstructionObject) - Method in class jhplot.HZirkel
Draw an object on the canvas.
draw(double[][], double[][]) - Method in class jhplot.SPlot
Draw multiple sets as marks (default).
draw(double[], double[]) - Method in class jhplot.SPlot
Draw a single data set as marks (default).
draw(String, double[], double[]) - Method in class jhplot.SPlot
Draw a single data set with a legend.
draw(String, double[], double[], double[]) - Method in class jhplot.SPlot
Draw a single data set with errors on Y with legend.
draw(H1D) - Method in class jhplot.SPlot
Draw H1D histograms
draw(P1D) - Method in class jhplot.SPlot
Draw P1D object.
draw(String[], double[][], double[][]) - Method in class jhplot.SPlot
Set sets of data with legends
drawBox() - Method in class jhplot.HPlot3D
Draw an empty frame
drawCdf(ContinuousDistribution, double, double, int, String) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Formats data to plot the graph of the distribution function F over the interval [a, b], and returns the result as a String.
drawData(VectorGraphics) - Method in class jhplot.jadraw.JaAxes
Draw data points
drawDensity(ContinuousDistribution, double, double, int, String) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Formats data to plot the graph of the density f (x) over the interval [a, b], and returns the result as a String.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaArcObject
Draws the handles of this JaxoArc.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaAxes
Draws the handles of this box object.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaBlob
Draws a visual aid during the dragging of a blob object, which is a red cross at the center.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaBox
Draws the handles of this box object.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaKey
Draws the handles of this text object.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaLatexText
Draws the handles of this text object.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaLineObject
Draws the handles of this line object.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaLoopObject
Draws the handles of this loop object.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaObject
Draws the handles of this JaObject that allow to move/resize/edit it.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaText
Draws the handles of this text object.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaTextBox
Draws the handles of this box object.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaVertex
Draws the handles of this vertex object.
drawHandles(VectorGraphics) - Method in class jhplot.jadraw.JaVertexT5
Draws the handles of this vertex object.
drawItem(Graphics2D, XYItemRendererState, Rectangle2D, PlotRenderingInfo, XYPlot, ValueAxis, ValueAxis, XYDataset, int, int, CrosshairState, int) - Method in class umontreal.iro.lecuyer.charts.EmpiricalRenderer
Draws the visual representation of a single data item.
DrawOptions - Class in jhplot
Main class which sets graphic attributes for all jHPlot classes (histograms and data holders).
DrawOptions() - Constructor for class jhplot.DrawOptions
Sets drawing options
drawStatBox(H1D) - Method in class jhplot.HPlot
Draw a statistical box (mean, RMS, number of entries)
drawStatBox(H1D, int, int) - Method in class jhplot.HPlot
Draw a statistical box (mean, RMS, number of entries) at a specific position.
drawTextBox(String[]) - Method in class jhplot.HPlot
Draw a text box with some information
drawTexVisualAid(VectorGraphics) - Method in class jhplot.jadraw.JaLatexText
Draws a visual aid for a tex label: a blu TeX icon.
drawVisualAid(VectorGraphics) - Method in class jhplot.jadraw.JaArcObject
Draws a visual aid during the dragging of an arc object.
drawVisualAid(VectorGraphics) - Method in class jhplot.jadraw.JaBlob
Draws a visual aid during the dragging of a blob object, which is a red cross at the center.
drawVisualAid(VectorGraphics) - Method in class jhplot.jadraw.JaLoopObject
Draws a visual aid during the dragging of a loop object, which is a red cross at the center.
drawVisualAid(VectorGraphics) - Method in class jhplot.jadraw.JaObject
Draws a visual aid for the user during dragging of certain JaxoObjects.
drawVisualAid(VectorGraphics) - Method in class jhplot.jadraw.JaVertex
Draws a visual aid during the dragging of a vertex object, which is a red cross at the center.
drawVisualAid(VectorGraphics) - Method in class jhplot.jadraw.JaVertexT5
Draws a visual aid during the dragging of a vertex object, which is a red cross at the center.
drot(DoubleMatrix1D, DoubleMatrix1D, double, double) - Method in interface cern.colt.matrix.linalg.Blas
Applies a givens plane rotation to (x,y); x = c*x + s*y; y = c*y - s*x.
drot(DoubleMatrix1D, DoubleMatrix1D, double, double) - Method in class cern.colt.matrix.linalg.SeqBlas
 
drot(DoubleMatrix1D, DoubleMatrix1D, double, double) - Method in class cern.colt.matrix.linalg.SmpBlas
 
drot(DoubleMatrix1D, DoubleMatrix1D, double, double) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Applies a givens plane rotation to (x,y); x = c*x + s*y; y = c*y - s*x.
drot(DoubleMatrix1D, DoubleMatrix1D, double, double) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
drot(FloatMatrix1D, FloatMatrix1D, float, float) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Applies a givens plane rotation to (x,y); x = c*x + s*y; y = c*y - s*x.
drot(FloatMatrix1D, FloatMatrix1D, float, float) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
drot(int, double[], int, double[], int, double, double) - Method in class org.netlib.blas.BLAS
..
drotg(double, double, double[]) - Method in interface cern.colt.matrix.linalg.Blas
Constructs a Givens plane rotation for (a,b).
drotg(double, double, double[]) - Method in class cern.colt.matrix.linalg.SeqBlas
 
drotg(double, double, double[]) - Method in class cern.colt.matrix.linalg.SmpBlas
 
drotg(double, double, double[]) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Constructs a Givens plane rotation for (a,b).
drotg(double, double, double[]) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
drotg(float, float, float[]) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Constructs a Givens plane rotation for (a,b).
drotg(float, float, float[]) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
drotg(doubleW, doubleW, doubleW, doubleW) - Method in class org.netlib.blas.BLAS
..
drotm(int, double[], int, double[], int, double[]) - Method in class org.netlib.blas.BLAS
..
drotmg(doubleW, doubleW, doubleW, double, double[]) - Method in class org.netlib.blas.BLAS
..
drscl(int, double, double[], int) - Method in class org.netlib.lapack.LAPACK
..
dsaitr(intW, String, int, int, int, int, double[], doubleW, double[], int, double[], int, int[], double[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dsapps(int, int, int, double[], double[], int, double[], int, double[], double[], int, double[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dsaup2(intW, String, int, String, intW, intW, double, double[], int, int, int, intW, double[], int, double[], int, double[], double[], double[], int, double[], int[], double[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dsaupd(intW, String, int, String, int, doubleW, double[], int, double[], int, int[], int[], double[], double[], int, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dsbev(String, String, int, int, double[], int, double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsbevd(String, String, int, int, double[], int, double[], double[], int, double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsbevx(String, String, String, int, int, double[], int, double[], int, double, double, int, int, double, intW, double[], double[], int, double[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsbgst(String, String, int, int, int, double[], int, double[], int, double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsbgv(String, String, int, int, int, double[], int, double[], int, double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsbgvd(String, String, int, int, int, double[], int, double[], int, double[], double[], int, double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsbgvx(String, String, String, int, int, int, double[], int, double[], int, double[], int, double, double, int, int, double, intW, double[], double[], int, double[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsbmv(String, int, int, double, double[], int, double[], int, double, double[], int) - Method in class org.netlib.blas.BLAS
..
dsbtrd(String, String, int, int, double[], int, double[], double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dscal(double, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Vector scaling; x = alpha*x.
dscal(double, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Matrix scaling; A = alpha*A.
dscal(double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dscal(double, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dscal(double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dscal(double, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dscal(double, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Vector scaling; x = alpha*x.
dscal(double, DoubleMatrix2D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Matrix scaling; A = alpha*A.
dscal(double, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dscal(double, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dscal(float, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Vector scaling; x = alpha*x.
dscal(float, FloatMatrix2D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Matrix scaling; A = alpha*A.
dscal(float, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dscal(float, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dscal(int, double, double[], int) - Method in class org.netlib.blas.BLAS
..
dsconv(int, double[], double[], double, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dsecnd() - Method in class org.netlib.lapack.LAPACK
-- LAPACK auxiliary routine (version 3.1.1) -- Univ.
dseigt(double, int, double[], int, double[], double[], double[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dsesrt(String, boolean, int, double[], int, double[], int) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dseupd(boolean, String, boolean[], double[], double[], int, double, String, int, String, intW, double, double[], int, double[], int, int[], int[], double[], double[], int, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dsgesv(int, int, double[], int, int[], double[], int, double[], int, double[], float[], intW, intW) - Method in class org.netlib.lapack.LAPACK
..
dsgets(int, String, intW, intW, double[], double[], double[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
DSOLProcessSimulator - Class in umontreal.iro.lecuyer.simprocs
Represents a simulation process whose actions method is interpreted by the DSOL interpreter, written by Peter Jacobs (http://www.tbm.tudelft.nl/webstaf/peterja/index.htm).
DSOLProcessSimulator() - Constructor for class umontreal.iro.lecuyer.simprocs.DSOLProcessSimulator
Constructs a new DSOLProcessSimulator variable without initialization.
dsortc(String, boolean, int, double[], double[], double[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dsortr(String, boolean, int, double[], double[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dspcon(String, int, double[], int[], double, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dspev(String, String, int, double[], double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dspevd(String, String, int, double[], double[], double[], int, double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dspevx(String, String, String, int, double[], double, double, int, int, double, intW, double[], double[], int, double[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dspgst(int, String, int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dspgv(int, String, String, int, double[], double[], double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dspgvd(int, String, String, int, double[], double[], double[], double[], int, double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dspgvx(int, String, String, String, int, double[], double[], double, double, int, int, double, intW, double[], double[], int, double[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dspmv(String, int, double, double[], double[], int, double, double[], int) - Method in class org.netlib.blas.BLAS
..
dspr(String, int, double, double[], int, double[]) - Method in class org.netlib.blas.BLAS
..
dspr2(String, int, double, double[], int, double[], int, double[]) - Method in class org.netlib.blas.BLAS
..
dsprfs(String, int, int, double[], double[], int[], double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dspsv(String, int, int, double[], int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dspsvx(String, String, int, int, double[], double[], int[], double[], int, double[], int, doubleW, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsptrd(String, int, double[], double[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsptrf(String, int, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsptri(String, int, double[], int[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsptrs(String, int, int, double[], int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dst(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Computes the discrete sine transform (DST-II) of this matrix.
dst(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Computes the discrete sine transform (DST-II) of this matrix.
dst2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the 2D discrete sine transform (DST-II) of this matrix.
dst2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the 2D discrete sine transform (DST-II) of this matrix.
dst2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the 2D discrete sine transform (DST-II) of this matrix.
dst2(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the 2D discrete sine transform (DST-II) of this matrix.
dst2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the 2D discrete sine transform (DST-II) of this matrix.
dst2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the 2D discrete sine transform (DST-II) of this matrix.
dst2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the 2D discrete sine transform (DST-II) of this matrix.
dst2(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the 2D discrete sine transform (DST-II) of this matrix.
dst2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 2D discrete sine transform (DST-II) of each slice of this matrix.
dst2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 2D discrete sine transform (DST-II) of each slice of this matrix.
dst2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 2D discrete sine transform (DST-II) of each slice of this matrix.
dst2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 2D discrete sine transform (DST-II) of each slice of this matrix.
dst2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 2D discrete sine transform (DST-II) of each slice of this matrix.
dst2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 2D discrete sine transform (DST-II) of each slice of this matrix.
dst3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 3D discrete sine transform (DST-II) of this matrix.
dst3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 3D discrete sine transform (DST-II) of this matrix.
dst3(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 3D discrete sine transform (DST-II) of this matrix.
dst3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 3D discrete sine transform (DST-II) of this matrix.
dst3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 3D discrete sine transform (DST-II) of this matrix.
dst3(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 3D discrete sine transform (DST-II) of this matrix.
dstatn() - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dstats() - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dstColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the discrete sine transform (DST-II) of each column of this matrix.
dstColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the discrete sine transform (DST-II) of each column of this matrix.
dstColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the discrete sine transform (DST-II) of each column of this matrix.
dstColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the discrete sine transform (DST-II) of each column of this matrix.
dstColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the discrete sine transform (DST-II) of each column of this matrix.
dstColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the discrete sine transform (DST-II) of each column of this matrix.
dstColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the discrete sine transform (DST-II) of each column of this matrix.
dstColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the discrete sine transform (DST-II) of each column of this matrix.
dstebz(String, String, int, double, double, int, int, double, double[], double[], intW, intW, double[], int[], int[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dstedc(String, int, double[], double[], double[], int, double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dstegr(String, String, int, double[], double[], double, double, int, int, double, intW, double[], double[], int, int[], double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dstein(int, double[], double[], int, double[], int[], int[], double[], int, double[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dstemr(String, String, int, double[], double[], double, double, int, int, intW, double[], double[], int, int, int[], booleanW, double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsteqr(String, int, double[], double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsterf(int, double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dstev(String, int, double[], double[], double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dstevd(String, int, double[], double[], double[], int, double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dstevr(String, String, int, double[], double[], double, double, int, int, double, intW, double[], double[], int, int[], double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dstevx(String, String, int, double[], double[], double, double, int, int, double, intW, double[], double[], int, double[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dstqrb(int, double[], double[], double[], double[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
dstRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the discrete sine transform (DST-II) of each row of this matrix.
dstRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the discrete sine transform (DST-II) of each row of this matrix.
dstRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the discrete sine transform (DST-II) of each row of this matrix.
dstRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the discrete sine transform (DST-II) of each row of this matrix.
dstRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the discrete sine transform (DST-II) of each row of this matrix.
dstRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the discrete sine transform (DST-II) of each row of this matrix.
dstRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the discrete sine transform (DST-II) of each row of this matrix.
dstRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the discrete sine transform (DST-II) of each row of this matrix.
dswap(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Swaps the elements of two vectors; y <==> x.
dswap(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.linalg.Blas
Swaps the elements of two matrices; B <==> A.
dswap(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dswap(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dswap(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dswap(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dswap(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Swaps the elements of two vectors; y <==> x.
dswap(DoubleMatrix2D, DoubleMatrix2D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Swaps the elements of two matrices; B <==> A.
dswap(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dswap(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dswap(FloatMatrix1D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Swaps the elements of two vectors; y <==> x.
dswap(FloatMatrix2D, FloatMatrix2D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Swaps the elements of two matrices; B <==> A.
dswap(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dswap(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dswap(int, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dsycon(String, int, double[], int, int[], double, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsyev(String, String, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsyevd(String, String, int, double[], int, double[], double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsyevr(String, String, String, int, double[], int, double, double, int, int, double, intW, double[], double[], int, int[], double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsyevx(String, String, String, int, double[], int, double, double, int, int, double, intW, double[], double[], int, double[], int, int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsygs2(int, String, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsygst(int, String, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsygv(int, String, String, int, double[], int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsygvd(int, String, String, int, double[], int, double[], int, double[], double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsygvx(int, String, String, String, int, double[], int, double[], int, double, double, int, int, double, intW, double[], double[], int, double[], int, int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsymm(String, String, int, int, double, double[], int, double[], int, double, double[], int) - Method in class org.netlib.blas.BLAS
..
dsymv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Symmetric matrix-vector multiplication; y = alpha*A*x + beta*y.
dsymv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dsymv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dsymv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Symmetric matrix-vector multiplication; y = alpha*A*x + beta*y.
dsymv(boolean, double, DoubleMatrix2D, DoubleMatrix1D, double, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dsymv(boolean, float, FloatMatrix2D, FloatMatrix1D, float, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Symmetric matrix-vector multiplication; y = alpha*A*x + beta*y.
dsymv(boolean, float, FloatMatrix2D, FloatMatrix1D, float, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dsymv(String, int, double, double[], int, double[], int, double, double[], int) - Method in class org.netlib.blas.BLAS
..
dsyr(String, int, double, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dsyr2(String, int, double, double[], int, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dsyr2k(String, String, int, int, double, double[], int, double[], int, double, double[], int) - Method in class org.netlib.blas.BLAS
..
dsyrfs(String, int, int, double[], int, double[], int, int[], double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsyrk(String, String, int, int, double, double[], int, double, double[], int) - Method in class org.netlib.blas.BLAS
..
dsysv(String, int, int, double[], int, int[], double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsysvx(String, String, int, int, double[], int, double[], int, int[], double[], int, double[], int, doubleW, double[], double[], double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsytd2(String, int, double[], int, double[], double[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsytf2(String, int, double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsytrd(String, int, double[], int, double[], double[], double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsytrf(String, int, double[], int, int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dsytri(String, int, double[], int, int[], double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dsytrs(String, int, int, double[], int, int[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dtbcon(String, String, String, int, int, double[], int, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtbmv(String, String, String, int, int, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dtbrfs(String, String, String, int, int, int, double[], int, double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtbsv(String, String, String, int, int, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dtbtrs(String, String, String, int, int, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dtgevc(String, String, boolean[], int, double[], int, double[], int, double[], int, double[], int, int, intW, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtgex2(boolean, boolean, int, double[], int, double[], int, double[], int, double[], int, int, int, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dtgexc(boolean, boolean, int, double[], int, double[], int, double[], int, double[], int, intW, intW, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dtgsen(int, boolean, boolean, boolean[], int, double[], int, double[], int, double[], double[], double[], double[], int, double[], int, intW, doubleW, doubleW, double[], double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dtgsja(String, String, String, int, int, int, int, int, double[], int, double[], int, double, double, double[], double[], double[], int, double[], int, double[], int, double[], intW, intW) - Method in class org.netlib.lapack.LAPACK
..
dtgsna(String, String, boolean[], int, double[], int, double[], int, double[], int, double[], int, double[], double[], int, intW, double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtgsy2(String, int, int, int, double[], int, double[], int, double[], int, double[], int, double[], int, double[], int, doubleW, doubleW, doubleW, int[], intW, intW) - Method in class org.netlib.lapack.LAPACK
..
dtgsyl(String, int, int, int, double[], int, double[], int, double[], int, double[], int, double[], int, double[], int, doubleW, doubleW, double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtpcon(String, String, String, int, double[], doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtpmv(String, String, String, int, double[], double[], int) - Method in class org.netlib.blas.BLAS
..
dtprfs(String, String, String, int, int, double[], double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtpsv(String, String, String, int, double[], double[], int) - Method in class org.netlib.blas.BLAS
..
dtptri(String, String, int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtptrs(String, String, String, int, int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dtrcon(String, String, String, int, double[], int, doubleW, double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtrevc(String, String, boolean[], int, double[], int, double[], int, double[], int, int, intW, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtrexc(String, int, double[], int, double[], int, intW, intW, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtrmm(String, String, String, String, int, int, double, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dtrmv(boolean, boolean, boolean, DoubleMatrix2D, DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Triangular matrix-vector multiplication; x = A*x or x = A'*x.
dtrmv(boolean, boolean, boolean, DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
dtrmv(boolean, boolean, boolean, DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
dtrmv(boolean, boolean, boolean, DoubleMatrix2D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Triangular matrix-vector multiplication; x = A*x or x = A'*x.
dtrmv(boolean, boolean, boolean, DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
dtrmv(boolean, boolean, boolean, FloatMatrix2D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Triangular matrix-vector multiplication; x = A*x or x = A'*x.
dtrmv(boolean, boolean, boolean, FloatMatrix2D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
dtrmv(String, String, String, int, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dtrrfs(String, String, String, int, int, double[], int, double[], int, double[], int, double[], double[], double[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtrsen(String, String, boolean[], int, double[], int, double[], int, double[], double[], intW, doubleW, doubleW, double[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dtrsm(String, String, String, String, int, int, double, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dtrsna(String, String, boolean[], int, double[], int, double[], int, double[], int, double[], double[], int, intW, double[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtrsv(String, String, String, int, double[], int, double[], int) - Method in class org.netlib.blas.BLAS
..
dtrsyl(String, String, int, int, int, double[], int, double[], int, double[], int, doubleW, intW) - Method in class org.netlib.lapack.LAPACK
..
dtrti2(String, String, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dtrtri(String, String, int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dtrtrs(String, String, String, int, int, double[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dtzrqf(int, int, double[], int, double[], intW) - Method in class org.netlib.lapack.LAPACK
..
dtzrzf(int, int, double[], int, double[], double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
dualPartition(double[], double[], int, int, double[], int, int, int[]) - Static method in class cern.colt.Partitioning
Same as Partitioning.dualPartition(int[],int[],int,int,int[],int,int,int[]) except that it synchronously partitions double[] rather than int[] arrays.
dualPartition(double[], double[], int, int, double) - Static method in class cern.colt.Partitioning
Same as Partitioning.dualPartition(int[],int[],int,int,int) except that it synchronously partitions double[] rather than int[] arrays.
dualPartition(int[], int[], int, int, int[], int, int, int[]) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that this method synchronously partitions two arrays at the same time; both arrays are partially sorted according to the elements of the primary array.
dualPartition(int[], int[], int, int, int) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int) except that this method synchronously partitions two arrays at the same time; both arrays are partially sorted according to the elements of the primary array.
DummyLocalizable - Class in org.apache.commons.math.exception.util
Dummy implementation of the Localizable interface, without localization.
DummyLocalizable(String) - Constructor for class org.apache.commons.math.exception.util.DummyLocalizable
Simple constructor.
DummyStepHandler - Class in org.apache.commons.math.ode.sampling
This class is a step handler that does nothing.
DummyStepInterpolator - Class in org.apache.commons.math.ode.sampling
This class is a step interpolator that does nothing.
DummyStepInterpolator() - Constructor for class org.apache.commons.math.ode.sampling.DummyStepInterpolator
Simple constructor.
DummyStepInterpolator(double[], double[], boolean) - Constructor for class org.apache.commons.math.ode.sampling.DummyStepInterpolator
Simple constructor.
DummyStepInterpolator(DummyStepInterpolator) - Constructor for class org.apache.commons.math.ode.sampling.DummyStepInterpolator
Copy constructor.
DuplicateSampleAbscissaException - Exception in org.apache.commons.math
Exception thrown when a sample contains several entries at the same abscissa.
DuplicateSampleAbscissaException(double, int, int) - Constructor for exception org.apache.commons.math.DuplicateSampleAbscissaException
Construct an exception indicating the duplicate abscissa.
durbinWatson(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Durbin-Watson computation.
durbinWatson(DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Durbin-Watson computation.
durbinWatson(FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Durbin-Watson computation.
dvout(int, int, double[], int, String) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
DynamicBin1D - Class in cern.hep.aida.bin
1-dimensional rebinnable bin holding double elements; Efficiently computes advanced statistics of data sequences.
DynamicBin1D() - Constructor for class cern.hep.aida.bin.DynamicBin1D
Constructs and returns an empty bin; implicitly calls setFixedOrder(false).
DynamicDoubleBin1D - Class in hep.aida.tdouble.bin
1-dimensional rebinnable bin holding double elements; Efficiently computes advanced statistics of data sequences.
DynamicDoubleBin1D() - Constructor for class hep.aida.tdouble.bin.DynamicDoubleBin1D
Constructs and returns an empty bin; implicitly calls setFixedOrder(false).
DynamicFloatBin1D - Class in hep.aida.tfloat.bin
1-dimensional rebinnable bin holding float elements; Efficiently computes advanced statistics of data sequences.
DynamicFloatBin1D() - Constructor for class hep.aida.tfloat.bin.DynamicFloatBin1D
Constructs and returns an empty bin; implicitly calls setFixedOrder(false).

E

E - Static variable in class flanagan.math.Fmath
 
e(int, int) - Method in class hephysics.matrix.BasicMatrix
 
e(int, int) - Method in interface hephysics.matrix.Matrix
Returns the value of the given element
e(int, int) - Method in class hephysics.matrix.SymmetricMatrix
Returns a specific element
e(int, int) - Method in class hephysics.vec.Hep3Matrix
Returns the (row, column) element
e() - Method in class hephysics.vec.HepLorentzVector
Get energy
E - Static variable in class org.apache.commons.math.util.FastMath
Napier's constant e, base of the natural logarithm.
E(double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as E (0, 6, x).
E(int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as E (fieldwidth, 6, x).
E(int, int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Formats a double-precision number x like %E in C printf.
e(double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as e (0, 6, x).
e(int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as e (fieldwidth, 6, x).
e(int, int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
The same as E, except that `e' is used as the exponent character instead of `E'.
e_SI - Static variable in class cern.clhep.Units
 
e_squared - Static variable in class cern.clhep.PhysicalConstants
 
easterSunday() - Method in class flanagan.math.TimeAndDate
 
easterSunday(int) - Method in class flanagan.math.TimeAndDate
 
EBASE - Static variable in class umontreal.iro.lecuyer.util.Num
The constant e.
ebeDivide(double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Element-by-element division.
ebeDivide(FieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Element-by-element division.
ebeDivide(T[]) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Element-by-element division.
ebeDivide(ArrayFieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Element-by-element division.
ebeDivide(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Element-by-element division.
ebeDivide(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Element-by-element division.
ebeDivide(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Element-by-element division.
ebeDivide(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldVector
Element-by-element division.
ebeDivide(T[]) - Method in interface org.apache.commons.math.linear.FieldVector
Element-by-element division.
ebeDivide(RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Element-by-element division.
ebeDivide(double[]) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Element-by-element division.
ebeDivide(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Element-by-element division.
ebeDivide(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Element-by-element division.
ebeDivide(FieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Element-by-element division.
ebeDivide(T[]) - Method in class org.apache.commons.math.linear.SparseFieldVector
Element-by-element division.
ebeMultiply(double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Element-by-element multiplication.
ebeMultiply(FieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Element-by-element multiplication.
ebeMultiply(T[]) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Element-by-element multiplication.
ebeMultiply(ArrayFieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Element-by-element multiplication.
ebeMultiply(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Element-by-element multiplication.
ebeMultiply(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Element-by-element multiplication.
ebeMultiply(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Element-by-element multiplication.
ebeMultiply(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldVector
Element-by-element multiplication.
ebeMultiply(T[]) - Method in interface org.apache.commons.math.linear.FieldVector
Element-by-element multiplication.
ebeMultiply(RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Element-by-element multiplication.
ebeMultiply(double[]) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Element-by-element multiplication.
ebeMultiply(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Element-by-element multiplication.
ebeMultiply(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Element-by-element multiplication.
ebeMultiply(FieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Element-by-element multiplication.
ebeMultiply(T[]) - Method in class org.apache.commons.math.linear.SparseFieldVector
Element-by-element multiplication.
ec50() - Method in class flanagan.analysis.Regression
 
ec50constrained() - Method in class flanagan.analysis.Regression
 
ec50constrainedPlot() - Method in class flanagan.analysis.Regression
 
ec50Plot() - Method in class flanagan.analysis.Regression
 
edges(IAxis) - Method in class cern.hep.aida.ref.Converter
Returns all edges of the given axis.
edges(DoubleIAxis) - Method in class hep.aida.tdouble.ref.DoubleConverter
Returns all edges of the given axis.
edges(FloatIAxis) - Method in class hep.aida.tfloat.ref.FloatConverter
Returns all edges of the given axis.
editData() - Method in class jhplot.HNeuralNet
Edit data
editNetwork() - Method in class jhplot.HNeuralNet
Edit a neural net in a frame
Editor3d - Class in jhplot.v3d
 
Editor3d(Canvas3d, Model3d) - Constructor for class jhplot.v3d.Editor3d
 
editPanel() - Method in class jhplot.jadraw.JaArcObject
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaAxes
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaBlob
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaBox
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaFLine
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaGLine
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaGlLine
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaKey
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaLatexText
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaLine
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaLoopObject
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaObject
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaPLine
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaSLine
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaText
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaTextBox
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaVertex
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaVertexT1
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaVertexT2
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaVertexT3
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaVertexT4
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaVertexT5
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaVertexT6
Brings up the edit panel that allows to change the parameters of this object.
editPanel() - Method in class jhplot.jadraw.JaZigZagLine
Brings up the edit panel that allows to change the parameters of this object.
EEcentricity - Class in jhpro.stat
A class for accentricity calculations using a principle component analysis.
EEcentricity(double[], double[], double[]) - Constructor for class jhpro.stat.EEcentricity
Initialize 2D PCA analysis
EEcentricity(P1D) - Constructor for class jhpro.stat.EEcentricity
Perform PCA analysis using P1D object (in 2D).
effectiveSampleNumber() - Method in class flanagan.analysis.Stat
 
effectiveSampleNumber(double[]) - Static method in class flanagan.analysis.Stat
 
effectiveSampleNumber(float[]) - Static method in class flanagan.analysis.Stat
 
effectiveSampleNumber(Complex[]) - Static method in class flanagan.analysis.Stat
 
effectiveSampleNumber(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
effectiveSampleNumber(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
effectiveSampleNumber_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
effectiveSampleNumber_as_Complex() - Method in class flanagan.analysis.Stat
 
effectiveSampleNumber_as_double() - Method in class flanagan.analysis.Stat
 
effectiveSampleNumberConjugateCalcn(Complex[]) - Static method in class flanagan.analysis.Stat
 
EfficiencyBinError - Class in hep.aida.ref.dataset.binner
Calculates the bin error for efficiency-type histograms
EfficiencyBinError() - Constructor for class hep.aida.ref.dataset.binner.EfficiencyBinError
 
EfficiencyBinner - Class in hep.aida.ref.dataset.binner
This binner is for efficiency-type of data.
EfficiencyBinner(int[], String) - Constructor for class hep.aida.ref.dataset.binner.EfficiencyBinner
Creates a new instance of Binner.
EfficiencyBinner1D - Class in hep.aida.ref.histogram.binner
 
EfficiencyBinner1D(int) - Constructor for class hep.aida.ref.histogram.binner.EfficiencyBinner1D
Creates a new instance of EfficiencyBinner1D.
EfficiencyBinner1D(Binner1D) - Constructor for class hep.aida.ref.histogram.binner.EfficiencyBinner1D
 
EfficiencyBinner2D - Class in hep.aida.ref.histogram.binner
 
EfficiencyBinner2D(int, int) - Constructor for class hep.aida.ref.histogram.binner.EfficiencyBinner2D
Creates a new instance of EfficiencyBinner1D.
EfficiencyBinner3D - Class in hep.aida.ref.histogram.binner
 
EfficiencyBinner3D(int, int, int) - Constructor for class hep.aida.ref.histogram.binner.EfficiencyBinner3D
Creates a new instance of EfficiencyBinner1D.
EfficiencyBinnerUtils - Class in hep.aida.ref.histogram.binner
 
EfficiencyBinnerUtils() - Constructor for class hep.aida.ref.histogram.binner.EfficiencyBinnerUtils
 
EFile - Class in jhplot.io
Write data structures in sequential order into ntuples using Google's Prototype Buffer.
EFile(String, String) - Constructor for class jhplot.io.EFile
Open a file to write/read objects to/from a file in sequential order.
EFile(String) - Constructor for class jhplot.io.EFile
Open file for reading objects from a serialized file in sequential order.
eig(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Constructs and returns the Eigenvalue-decomposition of the given matrix.
eig(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Constructs and returns the Eigenvalue-decomposition of the given matrix.
eigen(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
EigenDecomposition - Interface in org.apache.commons.math.linear
An interface to classes that implement an algorithm to calculate the eigen decomposition of a real matrix.
EigenDecompositionImpl - Class in org.apache.commons.math.linear
Calculates the eigen decomposition of a real symmetric matrix.
EigenDecompositionImpl(RealMatrix, double) - Constructor for class org.apache.commons.math.linear.EigenDecompositionImpl
Calculates the eigen decomposition of the given symmetric matrix.
EigenDecompositionImpl(double[], double[], double) - Constructor for class org.apache.commons.math.linear.EigenDecompositionImpl
Calculates the eigen decomposition of the symmetric tridiagonal matrix.
EigenvalueDecomposition - Class in cern.colt.matrix.linalg
Eigenvalues and eigenvectors of a real matrix A.
EigenvalueDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.linalg.EigenvalueDecomposition
Constructs and returns a new eigenvalue decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
eigenValueIndices() - Method in class flanagan.analysis.PCA
 
eigenValueIndices() - Method in class flanagan.math.Matrix
 
eigenValues() - Method in class flanagan.analysis.PCA
 
eigenvalues(double, int) - Method in class jhplot.bsom.Matrix
Make a row vector including the eigenvalues of the matrix.
eigenValueTotal() - Method in class flanagan.analysis.PCA
 
eigenVectors() - Method in class flanagan.analysis.PCA
 
eigenVectorsAsRows() - Method in class flanagan.analysis.PCA
 
elapsedTime() - Method in class cern.colt.Timer
Same as seconds().
electron_charge - Static variable in class cern.clhep.PhysicalConstants
 
electron_Compton_length - Static variable in class cern.clhep.PhysicalConstants
 
electron_mass_c2 - Static variable in class cern.clhep.PhysicalConstants
 
electronvolt - Static variable in class cern.clhep.Units
 
elements() - Method in class cern.colt.bitvector.BitVector
You normally need not use this method.
elements(long[], int) - Method in class cern.colt.bitvector.BitVector
You normally need not use this method.
elements() - Method in class cern.colt.list.AbstractBooleanList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(boolean[]) - Method in class cern.colt.list.AbstractBooleanList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractByteList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(byte[]) - Method in class cern.colt.list.AbstractByteList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractCharList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(char[]) - Method in class cern.colt.list.AbstractCharList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractDoubleList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(double[]) - Method in class cern.colt.list.AbstractDoubleList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractFloatList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(float[]) - Method in class cern.colt.list.AbstractFloatList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractIntList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(int[]) - Method in class cern.colt.list.AbstractIntList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractLongList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(long[]) - Method in class cern.colt.list.AbstractLongList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.AbstractShortList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(short[]) - Method in class cern.colt.list.AbstractShortList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.BooleanArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(boolean[]) - Method in class cern.colt.list.BooleanArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.ByteArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(byte[]) - Method in class cern.colt.list.ByteArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.CharArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(char[]) - Method in class cern.colt.list.CharArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.DoubleArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(double[]) - Method in class cern.colt.list.DoubleArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.FloatArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(float[]) - Method in class cern.colt.list.FloatArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.IntArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(int[]) - Method in class cern.colt.list.IntArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.LongArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(long[]) - Method in class cern.colt.list.LongArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.ObjectArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(Object[]) - Method in class cern.colt.list.ObjectArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.ShortArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(short[]) - Method in class cern.colt.list.ShortArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(boolean[]) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.tboolean.BooleanArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(boolean[]) - Method in class cern.colt.list.tboolean.BooleanArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.tbyte.AbstractByteList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(byte[]) - Method in class cern.colt.list.tbyte.AbstractByteList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.tbyte.ByteArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(byte[]) - Method in class cern.colt.list.tbyte.ByteArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.tchar.AbstractCharList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(char[]) - Method in class cern.colt.list.tchar.AbstractCharList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.tchar.CharArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(char[]) - Method in class cern.colt.list.tchar.CharArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(double[]) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.tdouble.DoubleArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(double[]) - Method in class cern.colt.list.tdouble.DoubleArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(float[]) - Method in class cern.colt.list.tfloat.AbstractFloatList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.tfloat.FloatArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(float[]) - Method in class cern.colt.list.tfloat.FloatArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.tint.AbstractIntList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(int[]) - Method in class cern.colt.list.tint.AbstractIntList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.tint.IntArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(int[]) - Method in class cern.colt.list.tint.IntArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.tlong.AbstractLongList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(long[]) - Method in class cern.colt.list.tlong.AbstractLongList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.tlong.LongArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(long[]) - Method in class cern.colt.list.tlong.LongArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.tobject.ObjectArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(Object[]) - Method in class cern.colt.list.tobject.ObjectArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.list.tshort.AbstractShortList
Returns the elements currently stored, possibly including invalid elements between size and capacity.
elements(short[]) - Method in class cern.colt.list.tshort.AbstractShortList
Sets the receiver's elements to be the specified array.
elements() - Method in class cern.colt.list.tshort.ShortArrayList
Returns the elements currently stored, including invalid elements between size and capacity, if any.
elements(short[]) - Method in class cern.colt.list.tshort.ShortArrayList
Sets the receiver's elements to be the specified array (not a copy of it).
elements() - Method in class cern.colt.matrix.tbit.BitVector
You normally need not use this method.
elements(long[], int) - Method in class cern.colt.matrix.tbit.BitVector
You normally need not use this method.
elements() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix3D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCMDComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCMDComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
elements() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.SparseCCMDoubleMatrix2D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.SparseRCMDoubleMatrix2D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
elements() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
elements() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix3D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCMFComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCMFComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
elements() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
elements() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.SparseCCMFloatMatrix2D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.SparseRCMFloatMatrix2D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
elements() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
elements() - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
elements() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
elements() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
elements() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
elements() - Method in class cern.colt.matrix.tint.impl.DenseLargeIntMatrix2D
 
elements() - Method in class cern.colt.matrix.tint.impl.DenseLargeIntMatrix3D
 
elements() - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
elements() - Method in class cern.colt.matrix.tint.impl.SparseCCMIntMatrix2D
 
elements() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
elements() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
elements() - Method in class cern.colt.matrix.tint.impl.SparseRCMIntMatrix2D
 
elements() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
 
elements() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
elements() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
elements() - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tint.IntMatrix2D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tint.IntMatrix3D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
elements() - Method in class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix2D
 
elements() - Method in class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix3D
 
elements() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
elements() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
elements() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
elements() - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
elements() - Method in class cern.colt.matrix.tlong.impl.SparseCCMLongMatrix2D
 
elements() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
elements() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
elements() - Method in class cern.colt.matrix.tlong.impl.SparseRCMLongMatrix2D
 
elements() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
 
elements() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
elements() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
elements() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
elements() - Method in class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix2D
 
elements() - Method in class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix3D
 
elements() - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
 
elements() - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
elements() - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
elements() - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
elements() - Method in class cern.colt.matrix.tobject.impl.SparseCCMObjectMatrix2D
 
elements() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tobject.impl.SparseRCMObjectMatrix2D
 
elements() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
 
elements() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
elements() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
elements() - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Returns the elements of this matrix.
elements() - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Returns the elements of this matrix.
elements() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns a copy of the currently stored elements.
elements() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns a copy of the currently stored elements.
elements() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns a copy of the currently stored elements.
ElitisticListPopulation - Class in org.apache.commons.math.genetics
Population of chromosomes which uses elitism (certain percentace of the best chromosomes is directly copied to the next generation).
ElitisticListPopulation(List<Chromosome>, int, double) - Constructor for class org.apache.commons.math.genetics.ElitisticListPopulation
Creates a new ElitisticListPopulation instance.
ElitisticListPopulation(int, double) - Constructor for class org.apache.commons.math.genetics.ElitisticListPopulation
Creates a new ListPopulation instance and initializes its inner chromosome list.
Ellipse - Class in jhplot.shapes
Draw an ellipse in the USER coordinate system
Ellipse(double, double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.Ellipse
Create an ellipse
Ellipse(double, double, double, double) - Constructor for class jhplot.shapes.Ellipse
Create an ellipse using the default stroke and the color
ELLIPSE - Static variable in class jhplot.shapes.HShape
 
elm_coupling - Static variable in class cern.clhep.PhysicalConstants
 
EmbeddedRungeKuttaIntegrator - Class in org.apache.commons.math.ode.nonstiff
This class implements the common part of all embedded Runge-Kutta integrators for Ordinary Differential Equations.
Empirical - Class in cern.jet.random
Empirical distribution.
Empirical(double[], int, RandomEngine) - Constructor for class cern.jet.random.Empirical
Constructs an Empirical distribution.
Empirical - Class in cern.jet.random.tdouble
Empirical distribution.
Empirical(double[], int, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.Empirical
Constructs an Empirical distribution.
EmpiricalChart - Class in umontreal.iro.lecuyer.charts
This class provides additional tools to create and manage empirical plots.
EmpiricalChart() - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalChart
Initializes a new EmpiricalChart instance with an empty data set.
EmpiricalChart(String, String, String, double[]...) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalChart
Initializes a new EmpiricalChart instance with data data.
EmpiricalChart(String, String, String, double[], int) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalChart
Initializes a new EmpiricalChart instance with a set of points data.
EmpiricalChart(String, String, String, DoubleArrayList...) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalChart
Similar to the above constructor, but with DoubleArrayList.
EmpiricalChart(String, String, String, TallyStore...) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalChart
Initializes a new EmpiricalChart instance with data arrays contained in each TallyStore object.
EmpiricalChart(String, String, String, XYSeriesCollection) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalChart
Initializes a new EmpiricalChart instance with data data.
EmpiricalDist - Class in umontreal.iro.lecuyer.probdist
Extends DiscreteDistribution to an empirical distribution function, based on the observations X(1),..., X(n) (sorted by increasing order).
EmpiricalDist(double[]) - Constructor for class umontreal.iro.lecuyer.probdist.EmpiricalDist
Constructs a new empirical distribution using all the observations stored in obs, and which are assumed to have been sorted in increasing numerical order.
EmpiricalDist(Reader) - Constructor for class umontreal.iro.lecuyer.probdist.EmpiricalDist
Constructs a new empirical distribution using the observations read from the reader in.
EmpiricalDistribution - Interface in org.apache.commons.math.random
Represents an empirical probability distribution -- a probability distribution derived from observed data without making any assumptions about the functional form of the population distribution that the data come from.
EmpiricalDistributionImpl - Class in org.apache.commons.math.random
Implements EmpiricalDistribution interface.
EmpiricalDistributionImpl() - Constructor for class org.apache.commons.math.random.EmpiricalDistributionImpl
Creates a new EmpiricalDistribution with the default bin count.
EmpiricalDistributionImpl(int) - Constructor for class org.apache.commons.math.random.EmpiricalDistributionImpl
Creates a new EmpiricalDistribution with the specified bin count.
EmpiricalRenderer - Class in umontreal.iro.lecuyer.charts
A renderer that draws horizontal lines between points and/or draws shapes at each data point to provide an empirical style chart.
EmpiricalRenderer() - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalRenderer
Creates a new renderer.
EmpiricalRenderer(XYToolTipGenerator, XYURLGenerator) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalRenderer
Creates a new renderer with selected tool tip and url generators.
EmpiricalSeriesCollection - Class in umontreal.iro.lecuyer.charts
Stores data used in a EmpiricalChart.
EmpiricalSeriesCollection() - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Creates a new EmpiricalSeriesCollection instance with empty dataset.
EmpiricalSeriesCollection(double[]...) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Creates a new EmpiricalSeriesCollection instance with default parameters and given data series.
EmpiricalSeriesCollection(double[], int) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Creates a new EmpiricalSeriesCollection instance with default parameters and a given series data.
EmpiricalSeriesCollection(DoubleArrayList...) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Creates a new EmpiricalSeriesCollection instance with default parameters and given data.
EmpiricalSeriesCollection(TallyStore...) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Creates a new EmpiricalSeriesCollection instance with default parameters and given data.
EmpiricalSeriesCollection(XYSeriesCollection) - Constructor for class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Creates a new EmpiricalSeriesCollection instance with default parameters and given data series.
EmpiricalWalker - Class in cern.jet.random
Discrete Empirical distribution (pdf's can be specified).
EmpiricalWalker(double[], int, RandomEngine) - Constructor for class cern.jet.random.EmpiricalWalker
Constructs an Empirical distribution.
EmpiricalWalker - Class in cern.jet.random.tdouble
Discrete Empirical distribution (pdf's can be specified).
EmpiricalWalker(double[], int, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.EmpiricalWalker
Constructs an Empirical distribution.
EmptyRandomization - Class in umontreal.iro.lecuyer.hups
This class implements an empty PointSetRandomization.
EmptyRandomization() - Constructor for class umontreal.iro.lecuyer.hups.EmptyRandomization
 
enableAutoCompletion() - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Enables the auto completion option.
enableCustomLabels() - Method in class umontreal.iro.lecuyer.charts.Axis
Deprecated. 
enableDoubleBuffering(Component) - Static method in class jhplot.GHPanel
 
enableGrid(double, double) - Method in class umontreal.iro.lecuyer.charts.CategoryChart
Puts a grid on the background.
enableGrid(double, double) - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Puts grid on the background.
enableGrid(double, double) - Method in class umontreal.iro.lecuyer.charts.XYChart
Puts a grid on the background.
end() - Method in class org.apache.commons.math.linear.DefaultFieldMatrixChangingVisitor
End visiting a matrix.
end() - Method in class org.apache.commons.math.linear.DefaultFieldMatrixPreservingVisitor
End visiting a matrix.
end() - Method in class org.apache.commons.math.linear.DefaultRealMatrixChangingVisitor
End visiting a matrix.
end() - Method in class org.apache.commons.math.linear.DefaultRealMatrixPreservingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math.linear.FieldMatrixChangingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math.linear.FieldMatrixPreservingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math.linear.RealMatrixChangingVisitor
End visiting a matrix.
end() - Method in interface org.apache.commons.math.linear.RealMatrixPreservingVisitor
End visiting a matrix.
endOfBin(int) - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns the end of the range associated with the given bin.
endOfBin(int) - Method in class cern.jet.stat.tdouble.quantile.DoubleEquiDepthHistogram
Returns the end of the range associated with the given bin.
endOfBin(int) - Method in class cern.jet.stat.tfloat.quantile.FloatEquiDepthHistogram
Returns the end of the range associated with the given bin.
engineName() - Method in class hep.aida.ref.fitter.FitResult
 
engineName() - Method in class hep.aida.ref.fitter.Fitter
 
engsetLoad(double, double, double) - Static method in class flanagan.analysis.Stat
 
engsetLoad(double, long, long) - Static method in class flanagan.analysis.Stat
 
engsetLoad(double, int, int) - Static method in class flanagan.analysis.Stat
 
engsetProbability(double, double, double) - Static method in class flanagan.analysis.Stat
 
engsetProbability(double, long, long) - Static method in class flanagan.analysis.Stat
 
engsetProbability(double, int, int) - Static method in class flanagan.analysis.Stat
 
engsetResources(double, double, double) - Static method in class flanagan.analysis.Stat
 
engsetResources(double, double, long) - Static method in class flanagan.analysis.Stat
 
engsetResources(double, double, int) - Static method in class flanagan.analysis.Stat
 
engsetSources(double, double, double) - Static method in class flanagan.analysis.Stat
 
engsetSources(double, double, long) - Static method in class flanagan.analysis.Stat
 
engsetSources(double, double, int) - Static method in class flanagan.analysis.Stat
 
enlarge(int, boolean) - Method in class umontreal.iro.lecuyer.util.BitVector
Resizes the BitVector so that its length is equal to size.
enlarge(int) - Method in class umontreal.iro.lecuyer.util.BitVector
Resizes the BitVector so that its length is equal to size.
ensureCapacity(byte[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(char[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(double[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(float[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(int[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(long[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(Object[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(short[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(boolean[], int) - Static method in class cern.colt.Arrays
Ensures that a given array can hold up to minCapacity elements.
ensureCapacity(int) - Method in class cern.colt.list.AbstractBooleanList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractByteList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractCharList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractDoubleList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractFloatList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractIntList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractLongList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.AbstractShortList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.BooleanArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.ByteArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.CharArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.DistinctNumberList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.DoubleArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.FloatArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.IntArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.LongArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.MinMaxNumberList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.ObjectArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.ShortArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.SimpleLongArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tbyte.AbstractByteList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tbyte.ByteArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tchar.AbstractCharList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tchar.CharArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tdouble.DoubleArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tfloat.FloatArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tint.AbstractIntList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tint.IntArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tlong.AbstractLongList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tlong.DistinctNumberList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tlong.LongArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tlong.MinMaxNumberList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tlong.SimpleLongArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tobject.ObjectArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tshort.AbstractShortList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.list.tshort.ShortArrayList
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.AbstractMap
Ensures that the receiver can hold at least the specified number of elements without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.OpenDoubleIntHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.OpenIntDoubleHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.OpenIntIntHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.OpenIntObjectHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.OpenLongObjectHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Ensures that the receiver can hold at least the specified number of associations without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.AbstractMatrix
Ensures that the receiver can hold at least the specified number of non-zero (non-null) cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.AbstractMatrix
Ensures that the receiver can hold at least the specified number of non-zero (non-null) cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
ensureCapacity(int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
ensureCapacity(int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
ensureCapacity(int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
ensureCapacity(int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
ensureCapacity(int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
ensureCapacity(int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
ensureCapacity(int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
ensureCapacity(int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureCapacity(int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Ensures that the receiver can hold at least the specified number of non-zero cells without needing to allocate new internal memory.
ensureDirectory(File, File) - Static method in class jhplot.v3d.Util
Ensures the existence of the directory specified by the parameter.
ensureFilePath(File, File) - Static method in class jhplot.v3d.Util
Ensures the existence of the directory which may be part of the path specification of parameter file.
enterData(double[][], double[], double[]) - Method in class flanagan.analysis.Regression
 
enterData(double[][], double[][], double[][]) - Method in class flanagan.analysis.Regression
 
enterData(double[], double[], double[]) - Method in class flanagan.analysis.Regression
 
enterData(double[], double[][], double[][]) - Method in class flanagan.analysis.Regression
 
enterData(double[][], double[]) - Method in class flanagan.analysis.Regression
 
enterData(double[][], double[][]) - Method in class flanagan.analysis.Regression
 
enterData(double[], double[]) - Method in class flanagan.analysis.Regression
 
enterData(double[], double[][]) - Method in class flanagan.analysis.Regression
 
enterData(double[], double, double) - Method in class flanagan.analysis.Regression
 
enterData(double[], double) - Method in class flanagan.analysis.Regression
 
enterItemNames(String[]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerIperson(String[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerItem(String[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerItem(double[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerItem(Matrix) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerItem(float[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerItem(int[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerItem(char[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerItem(boolean[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerPerson(double[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerPerson(Matrix) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerPerson(float[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerPerson(int[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerPerson(char[][]) - Method in class flanagan.analysis.Scores
 
enterScoresAsRowPerPerson(boolean[][]) - Method in class flanagan.analysis.Scores
 
enterTitle(String) - Method in class flanagan.analysis.Scores
 
entries(int[]) - Method in interface hep.aida.ref.dataset.binner.Binner
Get the number of entries in a bin.
entries(int[]) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Get the number of entries in a bin.
entries() - Method in class hep.aida.ref.dataset.DataStatistics
Get the number of entries in this data set
entries() - Method in class hep.aida.ref.fitter.fitdata.FitDataIterator
 
entries() - Method in class hep.aida.ref.histogram.AbstractBaseHistogram
Number of in-range entries in the histogram.
entries(int) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
entries(int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
entries(int, int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
entries(int) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
entries(int, int) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
entries(int, int, int) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
entries(int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
entries(int, int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
entries() - Method in class hep.aida.ref.histogram.Cloud1D
Get the Cloud's entries.
entries() - Method in class hep.aida.ref.histogram.Cloud2D
Get the Cloud's entries.
entries() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's entries.
entries() - Method in class hep.aida.ref.histogram.Histogram
Get the entries that are within the range of the Histogram; i.e.
entries() - Method in class hep.aida.ref.histogram.Profile1D
 
entries() - Method in class hep.aida.ref.histogram.Profile2D
 
entries() - Method in interface hep.aida.tdouble.DoubleIHistogram
Number of in-range entries in the histogram.
entries() - Method in interface hep.aida.tfloat.FloatIHistogram
Number of in-range entries in the histogram.
entries() - Method in class jhplot.H1D
Number of in-range entries in the histogram
entries() - Method in class jhplot.H2D
Number of in-range entries in the histogram
entries() - Method in class jhplot.HProf1D
Number of in-range entries in the histogram
entries() - Method in class jhplot.HProf2D
Number of in-range entries in the histogram
entriesToString() - Method in class jhplot.io.EFile
Get a string representing file content.
entriesToString() - Method in class jhplot.io.PFile
Get a string representing file content.
enumerateKeys() - Method in class jhplot.io.BaseRecordsFile
Returns an Enumeration of the keys of all records in the database.
enumerateKeys() - Method in class jhplot.io.RecordsFile
Returns an enumeration of all the keys in the database.
epiphany() - Method in class flanagan.math.TimeAndDate
 
epiphany(int) - Method in class flanagan.math.TimeAndDate
 
eplus - Static variable in class cern.clhep.Units
 
epsilon - Static variable in class jhplot.math.Slicing
 
EPSILON - Static variable in class org.apache.commons.math.util.MathUtils
Smallest positive number such that 1 - EPSILON is not numerically equal to 1.
EPSILON - Static variable in class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
Environment variable that determines what probability terms can be considered as negligible when building precomputed tables for distribution and mass functions.
epsilon0 - Static variable in class cern.clhep.PhysicalConstants
 
EPSILON_0 - Static variable in class flanagan.math.Fmath
 
EPSILONAD - Static variable in class umontreal.iro.lecuyer.gof.GofStat
 
epsilonCeiling(double) - Static method in class cern.jet.stat.Utils
Similar to Math.ceil(value), but adjusts small numerical rounding errors +- epsilon.
EPSILONP - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Environment variable used in formatp0 to determine which p-values are too close to 0 or 1 to be printed explicitly.
equals(Object) - Method in class cern.colt.bitvector.BitMatrix
Compares this object against the specified object.
equals(Object) - Method in class cern.colt.bitvector.BitVector
Compares this object against the specified object.
equals(Object) - Method in interface cern.colt.function.ByteComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.CharComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.DoubleComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.FloatComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.IntComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.LongComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.ShortComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.tbyte.ByteComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.tchar.CharComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.tdouble.DoubleComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.tfloat.FloatComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.tint.IntComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.tlong.LongComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.function.tshort.ShortComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in class cern.colt.list.AbstractBooleanList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractByteList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractCharList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractDoubleList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractFloatList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractIntList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractLongList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.AbstractShortList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.BooleanArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.ByteArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.CharArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.DoubleArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.FloatArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.IntArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.LongArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.ObjectArrayList
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.list.ObjectArrayList
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.colt.list.ShortArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tboolean.BooleanArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tbyte.AbstractByteList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tbyte.ByteArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tchar.AbstractCharList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tchar.CharArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tdouble.DoubleArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tfloat.AbstractFloatList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tfloat.FloatArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tint.AbstractIntList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tint.IntArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tlong.AbstractLongList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tlong.LongArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tobject.ObjectArrayList
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.list.tobject.ObjectArrayList
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.colt.list.tshort.AbstractShortList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.list.tshort.ShortArrayList
Compares the specified Object with the receiver.
equals(Object) - Method in class cern.colt.map.AbstractDoubleIntMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.AbstractIntDoubleMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.AbstractIntIntMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.AbstractIntObjectMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.AbstractLongObjectMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tint.AbstractIntIntMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Compares the specified object with this map for equality.
equals(Object) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Compares the specified object with this map for equality.
equals(Object) - Method in interface cern.colt.matrix.doublealgo.DoubleMatrix1DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.matrix.doublealgo.DoubleMatrix2DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A[row,col] = A[row,col] == s ? 1 : 0; ignores tolerance.
equals(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A[row,col] = A[row,col] == B[row,col] ? 1 : 0; ignores tolerance.
equals(double) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.DoubleMatrix1D
Compares this object against the specified object.
equals(double) - Method in class cern.colt.matrix.DoubleMatrix2D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.DoubleMatrix2D
Compares this object against the specified object.
equals(double) - Method in class cern.colt.matrix.DoubleMatrix3D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.DoubleMatrix3D
Compares this object against the specified object.
equals(DoubleMatrix1D, double) - Method in class cern.colt.matrix.linalg.Property
Returns whether all cells of the given matrix A are equal to the given value.
equals(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Property
Returns whether both given matrices A and B are equal.
equals(DoubleMatrix2D, double) - Method in class cern.colt.matrix.linalg.Property
Returns whether all cells of the given matrix A are equal to the given value.
equals(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Returns whether both given matrices A and B are equal.
equals(DoubleMatrix3D, double) - Method in class cern.colt.matrix.linalg.Property
Returns whether all cells of the given matrix A are equal to the given value.
equals(DoubleMatrix3D, DoubleMatrix3D) - Method in class cern.colt.matrix.linalg.Property
Returns whether both given matrices A and B are equal.
equals(Object) - Method in interface cern.colt.matrix.objectalgo.ObjectMatrix1DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.matrix.objectalgo.ObjectMatrix2DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in class cern.colt.matrix.ObjectMatrix1D
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.matrix.ObjectMatrix1D
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.colt.matrix.ObjectMatrix2D
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.matrix.ObjectMatrix2D
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.colt.matrix.ObjectMatrix3D
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.matrix.ObjectMatrix3D
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.colt.matrix.tbit.BitMatrix
Compares this object against the specified object.
equals(Object) - Method in class cern.colt.matrix.tbit.BitVector
Compares this object against the specified object.
equals(DComplexMatrix1D, double[]) - Method in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(DComplexMatrix1D, DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
Returns whether both given matrices A and B are equal.
equals(DComplexMatrix2D, double[]) - Method in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(DComplexMatrix2D, DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
Returns whether both given matrices A and B are equal.
equals(DComplexMatrix3D, double[]) - Method in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(DComplexMatrix3D, DComplexMatrix3D) - Method in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
Returns whether both given matrices A and B are equal.
equals(double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Compares this object against the specified object.
equals(double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Compares this object against the specified object.
equals(double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Compares this object against the specified object.
equals(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
equals(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
equals(Object) - Method in interface cern.colt.matrix.tdouble.algo.DoubleMatrix1DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.matrix.tdouble.algo.DoubleMatrix2DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(DoubleMatrix1D, double) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Returns whether both given matrices A and B are equal.
equals(DoubleMatrix2D, double) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Returns whether both given matrices A and B are equal.
equals(DoubleMatrix3D, double) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(DoubleMatrix3D, DoubleMatrix3D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Returns whether both given matrices A and B are equal.
equals(double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Compares this object against the specified object.
equals(double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Compares this object against the specified object.
equals(double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Compares this object against the specified object.
equals(double) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
equals(double) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
equals(FComplexMatrix1D, float[]) - Method in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(FComplexMatrix1D, FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
Returns whether both given matrices A and B are equal.
equals(FComplexMatrix2D, float[]) - Method in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(FComplexMatrix2D, FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
Returns whether both given matrices A and B are equal.
equals(FComplexMatrix3D, float[]) - Method in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(FComplexMatrix3D, FComplexMatrix3D) - Method in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
Returns whether both given matrices A and B are equal.
equals(float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Compares this object against the specified object.
equals(float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Compares this object against the specified object.
equals(float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Compares this object against the specified object.
equals(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
equals(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
equals(Object) - Method in interface cern.colt.matrix.tfloat.algo.FloatMatrix1DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.matrix.tfloat.algo.FloatMatrix2DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(FloatMatrix1D, float) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Returns whether both given matrices A and B are equal.
equals(FloatMatrix2D, float) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Returns whether both given matrices A and B are equal.
equals(FloatMatrix3D, float) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(FloatMatrix3D, FloatMatrix3D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Returns whether both given matrices A and B are equal.
equals(float) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Compares this object against the specified object.
equals(float) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Compares this object against the specified object.
equals(float) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Compares this object against the specified object.
equals(float) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
equals(float) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
equals(Object) - Method in interface cern.colt.matrix.tint.algo.IntMatrix1DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.matrix.tint.algo.IntMatrix2DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(IntMatrix1D, int) - Method in class cern.colt.matrix.tint.algo.IntProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(IntMatrix1D, IntMatrix1D) - Method in class cern.colt.matrix.tint.algo.IntProperty
Returns whether both given matrices A and B are equal.
equals(IntMatrix2D, int) - Method in class cern.colt.matrix.tint.algo.IntProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(IntMatrix2D, IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
Returns whether both given matrices A and B are equal.
equals(IntMatrix3D, int) - Method in class cern.colt.matrix.tint.algo.IntProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(IntMatrix3D, IntMatrix3D) - Method in class cern.colt.matrix.tint.algo.IntProperty
Returns whether both given matrices A and B are equal.
equals(int) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
equals(int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
equals(int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tint.IntMatrix1D
Compares this object against the specified object.
equals(int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tint.IntMatrix2D
Compares this object against the specified object.
equals(int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tint.IntMatrix3D
Compares this object against the specified object.
equals(Object) - Method in interface cern.colt.matrix.tlong.algo.LongMatrix1DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.matrix.tlong.algo.LongMatrix2DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(LongMatrix1D, long) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(LongMatrix1D, LongMatrix1D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Returns whether both given matrices A and B are equal.
equals(LongMatrix2D, long) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(LongMatrix2D, LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Returns whether both given matrices A and B are equal.
equals(LongMatrix3D, long) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Returns whether all cells of the given matrix A are equal to the given value.
equals(LongMatrix3D, LongMatrix3D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Returns whether both given matrices A and B are equal.
equals(long) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
equals(long) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
equals(long) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Compares this object against the specified object.
equals(long) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Compares this object against the specified object.
equals(long) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Returns whether all cells are equal to the given value.
equals(Object) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Compares this object against the specified object.
equals(Object) - Method in interface cern.colt.matrix.tobject.algo.ObjectMatrix1DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in interface cern.colt.matrix.tobject.algo.ObjectMatrix2DComparator
Indicates whether some other object is "equal to" this Comparator.
equals(Object) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
equals(Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Compares the specified Object with the receiver for equality.
equals(Object, boolean) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Compares the specified Object with the receiver for equality.
equals(Object) - Method in class cern.hep.aida.bin.AbstractBin
Returns whether two objects are equal; This default implementation returns true if the other object is a bin and has the same size, value, error and center.
equals(Object) - Method in class cern.hep.aida.bin.AbstractBin1D
Returns whether two bins are equal; They are equal if the other object is of the same class or a subclass of this class and both have the same size, minimum, maximum, sum and sumOfSquares.
equals(Object) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns whether two bins are equal.
equals - Static variable in class cern.jet.math.Functions
Function that returns a == b ? 1 : 0.
equals(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a == b ? 1 : 0.
equals - Static variable in class cern.jet.math.IntFunctions
Function that returns a == b ? 1 : 0.
equals(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a == b ? 1 : 0.
equals(double[], double[], double) - Static method in class cern.jet.math.tdcomplex.DComplex
 
equals - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
equals(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
equals - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a == b ? 1 : 0.
equals(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a == b ? 1 : 0.
equals(float[], float[], float) - Static method in class cern.jet.math.tfcomplex.FComplex
 
equals - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
equals(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
equals - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a == b ? 1 : 0.
equals(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a == b ? 1 : 0.
equals - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a == b ? 1 : 0.
equals(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a == b ? 1 : 0.
equals - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a == b ? 1 : 0.
equals(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a == b ? 1 : 0.
equals(Object) - Method in class hep.aida.ref.histogram.FixedAxis
Check if two Axis are equal.
equals(Object) - Method in class hep.aida.ref.histogram.VariableAxis
Check if two Axis are equal.
equals(Object) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns whether two objects are equal; This default implementation returns true if the other object is a bin and has the same size, value, error and center.
equals(Object) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns whether two bins are equal; They are equal if the other object is of the same class or a subclass of this class and both have the same size, minimum, maximum, sum and sumOfSquares.
equals(Object) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns whether two bins are equal.
equals(Object) - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns whether two objects are equal; This default implementation returns true if the other object is a bin and has the same size, value, error and center.
equals(Object) - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns whether two bins are equal; They are equal if the other object is of the same class or a subclass of this class and both have the same size, minimum, maximum, sum and sumOfSquares.
equals(Object) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns whether two bins are equal.
equals(Object) - Method in class hephysics.vec.Hep3Vector
 
equals(Object) - Method in class hephysics.vec.HepLorentzVector
Compre 2 vectors
equals(SpacePoint, double) - Method in class hephysics.vec.SpacePoint
Tests for equality within errors
equals(Hep3Vector, double) - Method in class hephysics.vec.SpacePoint
Tests for equality within errors
equals(SpacePoint) - Method in class hephysics.vec.SpacePoint
Tests for equality
equals(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Deprecated. Use java.util.Arrays instead.
equals(Vector3d) - Method in class jhplot.v3d.Vector3d
 
equals(Object) - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
equals(Object) - Method in class org.apache.commons.math.complex.Complex
Test for the equality of two Complex objects.
equals(Object) - Method in class org.apache.commons.math.dfp.Dfp
Check if instance is equal to x.
equals(Object) - Method in class org.apache.commons.math.fraction.BigFraction
Test for the equality of two fractions.
equals(Object) - Method in class org.apache.commons.math.fraction.Fraction
Test for the equality of two fractions.
equals(Object) - Method in class org.apache.commons.math.geometry.Vector3D
Test for the equality of two 3D vectors.
equals(Object) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns true iff object is a FieldMatrix instance with the same dimensions as this and all corresponding matrix entries are equal.
equals(Object) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns true iff object is a RealMatrix instance with the same dimensions as this and all corresponding matrix entries are equal.
equals(Object) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Test for the equality of two real vectors.
equals(Object) - Method in class org.apache.commons.math.linear.ArrayRealVector
Test for the equality of two real vectors.
equals(Object) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns true iff object is a BigMatrixImpl instance with the same dimensions as this and all corresponding matrix entries are equal.
equals(Object) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Implementation Note: This performs an exact comparison, and as a result it is possible for a.subtract(b} to be the zero vector, while a.equals(b) == false.
equals(Object) - Method in class org.apache.commons.math.linear.SparseFieldVector
equals(Object) - Method in class org.apache.commons.math.optimization.linear.LinearConstraint
equals(Object) - Method in class org.apache.commons.math.optimization.linear.LinearObjectiveFunction
equals(Object) - Method in class org.apache.commons.math.stat.clustering.EuclideanIntegerPoint
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns true iff object is an AbstractStorelessUnivariateStatistic returning the same values as this for getResult() and getN()
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialMean
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns true iff object is a MultivariateSummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
Returns true iff object is a StatisticalSummaryValues instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns true iff object is a SummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns true iff object is a MultivariateSummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns true iff object is a SummaryStatistics instance and all statistics have the same values as this.
equals(Object) - Method in class org.apache.commons.math.stat.Frequency
equals(Object) - Method in class org.apache.commons.math.util.BigReal
equals(Object) - Method in class org.apache.commons.math.util.DefaultTransformer
equals(float, float) - Static method in class org.apache.commons.math.util.MathUtils
Deprecated. as of 2.2 his method considers that NaN == NaN. In release 3.0, the semantics will change in order to comply with IEEE754 where it is specified that NaN != NaN. New methods have been added for those cases wher the old semantics is useful (see e.g. equalsIncludingNaN.
equals(float, float, float) - Static method in class org.apache.commons.math.util.MathUtils
Returns true if both arguments are equal or within the range of allowed error (inclusive).
equals(float, float, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns true if both arguments are equal or within the range of allowed error (inclusive).
equals(float[], float[]) - Static method in class org.apache.commons.math.util.MathUtils
Deprecated. as of 2.2 this method considers that NaN == NaN. In release 3.0, the semantics will change in order to comply with IEEE754 where it is specified that NaN != NaN. New methods have been added for those cases where the old semantics is useful (see e.g. equalsIncludingNaN.
equals(double, double) - Static method in class org.apache.commons.math.util.MathUtils
Returns true iff both arguments are NaN or neither is NaN and they are equal
equals(double, double, double) - Static method in class org.apache.commons.math.util.MathUtils
Returns true if both arguments are equal or within the range of allowed error (inclusive).
equals(double, double, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns true if both arguments are equal or within the range of allowed error (inclusive).
equals(double[], double[]) - Static method in class org.apache.commons.math.util.MathUtils
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by MathUtils.equals(double,double).
equals(Object) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns true iff object is a ResizableDoubleArray with the same properties as this and an identical internal storage array.
equals(Object) - Method in class org.apache.commons.math.util.TransformerMap
equals(Object) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Tests this dataset for equality with an arbitrary object.
equals(Object) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
equals(BitMatrix) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Verifies that this and that are strictly identical.
equals(BitVector) - Method in class umontreal.iro.lecuyer.util.BitVector
Verifies if two BitVector's have the same length and the same data.
equalsIncludingNaN(float, float) - Static method in class org.apache.commons.math.util.MathUtils
Returns true if both arguments are NaN or neither is NaN and they are equal as defined by equals(x, y, 1).
equalsIncludingNaN(float, float, float) - Static method in class org.apache.commons.math.util.MathUtils
Returns true if both arguments are NaN or are equal or within the range of allowed error (inclusive).
equalsIncludingNaN(float, float, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns true if both arguments are NaN or if they are equal as defined by equals(x, y, maxUlps).
equalsIncludingNaN(float[], float[]) - Static method in class org.apache.commons.math.util.MathUtils
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by MathUtils.equalsIncludingNaN(float,float).
equalsIncludingNaN(double, double) - Static method in class org.apache.commons.math.util.MathUtils
Returns true if both arguments are NaN or neither is NaN and they are equal as defined by equals(x, y, 1).
equalsIncludingNaN(double, double, double) - Static method in class org.apache.commons.math.util.MathUtils
Returns true if both arguments are NaN or are equal or within the range of allowed error (inclusive).
equalsIncludingNaN(double, double, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns true if both arguments are NaN or if they are equal as defined by equals(x, y, maxUlps.
equalsIncludingNaN(double[], double[]) - Static method in class org.apache.commons.math.util.MathUtils
Returns true iff both arguments are null or have same dimensions and all their elements are equal as defined by MathUtils.equalsIncludingNaN(double,double).
EquiDepthHistogram - Class in cern.jet.stat.quantile
Read-only equi-depth histogram for selectivity estimation.
EquiDepthHistogram(float[]) - Constructor for class cern.jet.stat.quantile.EquiDepthHistogram
Constructs an equi-depth histogram with the given quantile elements.
equivalentBinEntries() - Method in class cern.hep.aida.ref.Histogram1D
 
equivalentBinEntries() - Method in class cern.hep.aida.ref.Histogram2D
 
equivalentBinEntries() - Method in class cern.hep.aida.ref.Histogram3D
 
equivalentBinEntries() - Method in class hep.aida.ref.histogram.Histogram
Get the number of equivalent entries; i.e.
equivalentBinEntries() - Method in interface hep.aida.tdouble.DoubleIHistogram
Number of equivalent entries.
equivalentBinEntries() - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
equivalentBinEntries() - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
equivalentBinEntries() - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
equivalentBinEntries() - Method in interface hep.aida.tfloat.FloatIHistogram
Number of equivalent entries.
equivalentBinEntries() - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
equivalentBinEntries() - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
equivalentBinEntries() - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
equivalentEntries() - Method in class hep.aida.ref.dataset.DataStatistics
Get the equivalent entries for this data set.
eraseOriginalGeneratorMatrices() - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Erases the original generator matrices and replaces them by the current ones.
ErasePermutations() - Method in class umontreal.iro.lecuyer.hups.HaltonSequence
Erases the Faure permutations: from now on, the digits will not be Faure permuted.
ErasePermutations() - Method in class umontreal.iro.lecuyer.hups.HammersleyPointSet
Erases the Faure permutations: from now on, the digits will not be Faure permuted.
erasePoint(int, int) - Method in class jhplot.SPlot
Erase the point at the given index in the given dataset.
erf(double) - Static method in class flanagan.analysis.Stat
 
Erf - Class in jhplot.math.num.special
Utility class that provides methods related to the error function.
erf(double) - Static method in class jhplot.math.num.special.Erf
Returns the error function erf(x) (1).
Erf - Class in org.apache.commons.math.special
This is a utility class that provides computation methods related to the error functions.
erf(double) - Static method in class org.apache.commons.math.special.Erf
Returns the error function
erf(double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of erf(x), the error function.
erfc(double) - Static method in class flanagan.analysis.Stat
 
erfc(double) - Static method in class jhplot.math.num.special.Erf
Returns the complementary error function erfc(x) (1).
erfc(double) - Static method in class org.apache.commons.math.special.Erf
Returns the complementary error function
erfc(double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of erfc(x), the complementary error function.
erfInv(double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of y = erf-1(x), the inverse of the error function such that x = erf(y).
erlang() - Method in class flanagan.analysis.Regression
 
erlangArray(double, int, int) - Method in class flanagan.math.PsRandom
 
erlangBload(double, double) - Static method in class flanagan.analysis.Stat
 
erlangBload(double, long) - Static method in class flanagan.analysis.Stat
 
erlangBload(double, int) - Static method in class flanagan.analysis.Stat
 
erlangBprobability(double, double) - Static method in class flanagan.analysis.Stat
 
erlangBprobability(double, long) - Static method in class flanagan.analysis.Stat
 
erlangBprobability(double, int) - Static method in class flanagan.analysis.Stat
 
erlangBresources(double, double) - Static method in class flanagan.analysis.Stat
 
erlangCDF(double, int, double) - Static method in class flanagan.analysis.Stat
 
erlangCDF(double, long, double) - Static method in class flanagan.analysis.Stat
 
erlangCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
erlangCload(double, double) - Static method in class flanagan.analysis.Stat
 
erlangCload(double, long) - Static method in class flanagan.analysis.Stat
 
erlangCload(double, int) - Static method in class flanagan.analysis.Stat
 
ErlangConvolutionGen - Class in umontreal.iro.lecuyer.randvar
This class implements Erlang random variate generators using the convolution method.
ErlangConvolutionGen(RandomStream, int, double) - Constructor for class umontreal.iro.lecuyer.randvar.ErlangConvolutionGen
Creates an Erlang random variate generator with parameters k and λ = lambda, using stream s.
ErlangConvolutionGen(RandomStream, int) - Constructor for class umontreal.iro.lecuyer.randvar.ErlangConvolutionGen
Creates an Erlang random variate generator with parameters k and λ = 1, using stream s.
ErlangConvolutionGen(RandomStream, ErlangDist) - Constructor for class umontreal.iro.lecuyer.randvar.ErlangConvolutionGen
Creates a new generator for the distribution dist and stream s.
erlangCprobability(double, double) - Static method in class flanagan.analysis.Stat
 
erlangCprobability(double, long) - Static method in class flanagan.analysis.Stat
 
erlangCprobability(double, int) - Static method in class flanagan.analysis.Stat
 
erlangCresources(double, double) - Static method in class flanagan.analysis.Stat
 
ErlangDist - Class in umontreal.iro.lecuyer.probdist
Extends the class GammaDist for the special case of the Erlang distribution with shape parameter k > 0 and scale parameter λ > 0.
ErlangDist(int) - Constructor for class umontreal.iro.lecuyer.probdist.ErlangDist
Constructs a ErlangDist object with parameters k = k and λ = 1.
ErlangDist(int, double) - Constructor for class umontreal.iro.lecuyer.probdist.ErlangDist
Constructs a ErlangDist object with parameters k = k and λ = lambda.
ErlangGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the Erlang distribution with parameters k > 0 and λ > 0.
ErlangGen(RandomStream, int, double) - Constructor for class umontreal.iro.lecuyer.randvar.ErlangGen
Creates an Erlang random variate generator with parameters k and λ = lambda, using stream s.
ErlangGen(RandomStream, int) - Constructor for class umontreal.iro.lecuyer.randvar.ErlangGen
Creates an Erlang random variate generator with parameters k and λ = 1, using stream s.
ErlangGen(RandomStream, ErlangDist) - Constructor for class umontreal.iro.lecuyer.randvar.ErlangGen
Creates a new generator for the distribution dist and stream s.
erlangMean(double, int) - Static method in class flanagan.analysis.Stat
 
erlangMean(double, long) - Static method in class flanagan.analysis.Stat
 
erlangMean(double, double) - Static method in class flanagan.analysis.Stat
 
erlangMode(double, int) - Static method in class flanagan.analysis.Stat
 
erlangMode(double, long) - Static method in class flanagan.analysis.Stat
 
erlangMode(double, double) - Static method in class flanagan.analysis.Stat
 
erlangMprobability(double, double, double) - Static method in class flanagan.analysis.Stat
 
erlangMprobability(double, long, long) - Static method in class flanagan.analysis.Stat
 
erlangMprobability(double, int, int) - Static method in class flanagan.analysis.Stat
 
erlangPDF(double, int, double) - Static method in class flanagan.analysis.Stat
 
erlangPDF(double, long, double) - Static method in class flanagan.analysis.Stat
 
erlangPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
erlangPlot() - Method in class flanagan.analysis.Regression
 
erlangRand(double, int, int) - Static method in class flanagan.analysis.Stat
 
erlangRand(double, long, int) - Static method in class flanagan.analysis.Stat
 
erlangRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
erlangRand(double, int, int, long) - Static method in class flanagan.analysis.Stat
 
erlangRand(double, long, int, long) - Static method in class flanagan.analysis.Stat
 
erlangRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
erlangStandardDeviation(double, int) - Static method in class flanagan.analysis.Stat
 
erlangStandardDeviation(double, long) - Static method in class flanagan.analysis.Stat
 
erlangStandardDeviation(double, double) - Static method in class flanagan.analysis.Stat
 
erlangStandDev(double, int) - Static method in class flanagan.analysis.Stat
 
erlangStandDev(double, long) - Static method in class flanagan.analysis.Stat
 
erlangStandDev(double, double) - Static method in class flanagan.analysis.Stat
 
ERR_SCALE - Static variable in class org.apache.commons.math.dfp.Dfp
The amount under/overflows are scaled by before going to trap handler
error() - Method in class cern.hep.aida.bin.AbstractBin
Returns error(0).
error(int) - Method in class cern.hep.aida.bin.AbstractBin
Returns a custom definable error measure; override this method if necessary.
error() - Method in class hep.aida.ref.fitter.fitdata.FitDataIterator
 
error() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns error(0).
error(int) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns a custom definable error measure; override this method if necessary.
error() - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns error(0).
error(int) - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns a custom definable error measure; override this method if necessary.
errorFunction(double) - Static method in class cern.jet.stat.Probability
Returns the error function of the normal distribution; formerly named erf.
errorFunction(double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the error function of the normal distribution; formerly named erf.
errorFunctionComplemented(double) - Static method in class cern.jet.stat.Probability
Returns the complementary Error function of the normal distribution; formerly named erfc.
errorFunctionComplemented(double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the complementary Error function of the normal distribution; formerly named erfc.
errorMinus() - Method in class hep.aida.ref.histogram.Measurement
 
errorPlus() - Method in class hep.aida.ref.histogram.Measurement
 
ErrorProp - Class in flanagan.analysis
 
ErrorProp() - Constructor for class flanagan.analysis.ErrorProp
 
ErrorProp(double, double) - Constructor for class flanagan.analysis.ErrorProp
 
ErrorProp(double) - Constructor for class flanagan.analysis.ErrorProp
 
errors() - Method in class hep.aida.ref.fitter.FitResult
 
errorsMinus() - Method in class hep.aida.ref.fitter.FitResult
 
errorsPlus() - Method in class hep.aida.ref.fitter.FitResult
 
estimate(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Deprecated. Solve an estimation problem.
estimate(EstimationProblem) - Method in interface org.apache.commons.math.estimation.Estimator
Deprecated. Solve an estimation problem.
estimate(EstimationProblem) - Method in class org.apache.commons.math.estimation.GaussNewtonEstimator
Deprecated. Solve an estimation problem using a least squares criterion.
estimate(EstimationProblem) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Deprecated. Solve an estimation problem using the Levenberg-Marquardt algorithm.
EstimatedParameter - Class in org.apache.commons.math.estimation
Deprecated. as of 2.0, everything in package org.apache.commons.math.estimation has been deprecated and replaced by package org.apache.commons.math.optimization.general
EstimatedParameter(String, double) - Constructor for class org.apache.commons.math.estimation.EstimatedParameter
Deprecated. Simple constructor.
EstimatedParameter(String, double, boolean) - Constructor for class org.apache.commons.math.estimation.EstimatedParameter
Deprecated. Simple constructor.
EstimatedParameter(EstimatedParameter) - Constructor for class org.apache.commons.math.estimation.EstimatedParameter
Deprecated. Copy constructor.
estimateErrorVariance() - Method in class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
Estimates the variance of the error.
estimateRegressandVariance() - Method in class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
Returns the variance of the regressand, ie Var(y).
estimateRegressandVariance() - Method in interface org.apache.commons.math.stat.regression.MultipleLinearRegression
Returns the variance of the regressand, ie Var(y).
estimateRegressionParameters() - Method in class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
Estimates the regression parameters b.
estimateRegressionParameters() - Method in interface org.apache.commons.math.stat.regression.MultipleLinearRegression
Estimates the regression parameters b.
estimateRegressionParametersStandardErrors() - Method in class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
Returns the standard errors of the regression parameters.
estimateRegressionParametersStandardErrors() - Method in interface org.apache.commons.math.stat.regression.MultipleLinearRegression
Returns the standard errors of the regression parameters.
estimateRegressionParametersVariance() - Method in class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
Estimates the variance of the regression parameters, ie Var(b).
estimateRegressionParametersVariance() - Method in interface org.apache.commons.math.stat.regression.MultipleLinearRegression
Estimates the variance of the regression parameters, ie Var(b).
estimateRegressionStandardError() - Method in class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
Estimates the standard error of the regression.
estimateResiduals() - Method in class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
Estimates the residuals, ie u = y - X*b.
estimateResiduals() - Method in interface org.apache.commons.math.stat.regression.MultipleLinearRegression
Estimates the residuals, ie u = y - X*b.
EstimationException - Exception in org.apache.commons.math.estimation
Deprecated. as of 2.0, everything in package org.apache.commons.math.estimation has been deprecated and replaced by package org.apache.commons.math.optimization.general
EstimationException(String, Object...) - Constructor for exception org.apache.commons.math.estimation.EstimationException
Deprecated. Simple constructor.
EstimationException(Localizable, Object...) - Constructor for exception org.apache.commons.math.estimation.EstimationException
Deprecated. Simple constructor.
EstimationProblem - Interface in org.apache.commons.math.estimation
Deprecated. as of 2.0, everything in package org.apache.commons.math.estimation has been deprecated and replaced by package org.apache.commons.math.optimization.general
Estimator - Interface in org.apache.commons.math.estimation
Deprecated. as of 2.0, everything in package org.apache.commons.math.estimation has been deprecated and replaced by package org.apache.commons.math.optimization.general
et() - Method in class hephysics.vec.HepLorentzVector
Transverse energy.
et2() - Method in class hephysics.vec.HepLorentzVector
Transverse energy squared.
EUCLID - Static variable in class cern.colt.matrix.doublealgo.Statistic
Euclidean distance function; Sqrt(Sum( (x[i]-y[i])^2 )).
EUCLID - Static variable in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Euclidean distance function; Sqrt(Sum( (x[i]-y[i])^2 )).
EUCLID - Static variable in class cern.colt.matrix.tfloat.algo.FloatStatistic
Euclidean distance function; Sqrt(Sum( (x[i]-y[i])^2 )).
EuclideanIntegerPoint - Class in org.apache.commons.math.stat.clustering
A simple implementation of Clusterable for points with integer coordinates.
EuclideanIntegerPoint(int[]) - Constructor for class org.apache.commons.math.stat.clustering.EuclideanIntegerPoint
Build an instance wrapping an integer array.
euler(double[], F1D, double) - Static method in class jhplot.math.Numeric
Uses the Euler method to solve an ODE.
EULER - Static variable in class umontreal.iro.lecuyer.util.Num
The Euler-Mascheroni constant.
EULER_CONSTANT_GAMMA - Static variable in class flanagan.math.Fmath
 
EulerIntegrator - Class in org.apache.commons.math.ode.nonstiff
This class implements a simple Euler integrator for Ordinary Differential Equations.
EulerIntegrator(double) - Constructor for class org.apache.commons.math.ode.nonstiff.EulerIntegrator
Simple constructor.
eV - Static variable in class cern.clhep.Units
 
eval(double) - Method in class jhplot.F1D
Evaluate a function at a specific point in x
eval(double[]) - Method in class jhplot.F1D
Evaluate a function for an array of x-values
eval(double, double) - Method in class jhplot.F1D
Evaluate a function for graphic representation.
eval(double, double, int) - Method in class jhplot.F1D
Evaluate a function for graphic representation.
eval() - Method in class jhplot.F1D
Evaluate a function for graphic representation.
eval(double, double) - Method in class jhplot.F2D
Evaluate a function at a specific point in (x,y)
eval(double[], double[]) - Method in class jhplot.F2D
Evaluate a function for an array of x-values
eval(double, double, double) - Method in class jhplot.F3D
Evaluate a function at a specific point in (x,y,z)
eval(String) - Method in class jhplot.FND
Evaluate a function at a specific point in x
eval(String, double, double, String) - Method in class jhplot.FND
Evaluate a function at a specific point for one single variable.
eval(String, double, double) - Method in class jhplot.FND
Evaluate a function at a specific point for one single variable.
eval() - Method in class jhplot.stat.BunchingParameters
Evaluate bunching parameters at the end of the run
eval() - Method in class jhplot.stat.FactorialMoments
Evaluate factorial moments at the end of the run
eval(float) - Method in class jhplot.stat.Interpolator.Cubic
Evaluate cubic function
eval() - Method in class jhplot.stat.PCA
 
evalCheby(double[], int, double) - Static method in class umontreal.iro.lecuyer.util.Num
Evaluates a series of Chebyshev polynomials Tj at x over the basic interval [- 1,  1].
evalChebyStar(double[], int, double) - Static method in class umontreal.iro.lecuyer.util.Num
Evaluates a series of shifted Chebyshev polynomials Tj* at x over the basic interval [0,  1].
evalPoly(int, double[], double[], double) - Static method in class umontreal.iro.lecuyer.util.Misc
Given n, X and C as described in interpol(n, X, Y, C), this function returns the value of the interpolating polynomial P(z) evaluated at z (see eq.
evalPoly(double[], int, double) - Static method in class umontreal.iro.lecuyer.util.Misc
Evaluates the polynomial
evaluate(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.AbstractFitMethod
 
evaluate(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.ChiSquaredFitMethod
 
evaluate(double[], double[]) - Method in class hep.aida.ref.function.JELCompiledExpression
 
evaluate(double) - Method in class jhplot.math.num.ContinuedFraction
Evaluate this continued fraction at the given value.
evaluate(double) - Method in interface jhplot.math.num.Function
Evaluate this function, f, at the domain value x.
evaluate(double) - Method in class jhplot.math.num.PowerSeries
Evaluate this series at the given value.
evaluate(double) - Method in class jhplot.math.num.Series
Evaluate this series at the given value.
evaluate(double[], double[], double) - Static method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionLagrangeForm
Evaluate the Lagrange polynomial using Neville's Algorithm.
evaluate(double[], double[], double) - Static method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionNewtonForm
Evaluate the Newton polynomial using nested multiplication.
evaluate(double[]) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation calls AbstractStorelessUnivariateStatistic.clear(), then invokes AbstractStorelessUnivariateStatistic.increment(double) in a loop over the the input array, and then uses AbstractStorelessUnivariateStatistic.getResult() to compute the return value.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation calls AbstractStorelessUnivariateStatistic.clear(), then invokes AbstractStorelessUnivariateStatistic.increment(double) in a loop over the specified portion of the input array, and then uses AbstractStorelessUnivariateStatistic.getResult() to compute the return value.
evaluate() - Method in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
Returns the result of evaluating the statistic over the stored data.
evaluate(double[]) - Method in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
Returns the result of evaluating the statistic over the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
Returns the result of evaluating the statistic over the specified entries in the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Returns the geometric mean of the entries in the specified portion of the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Returns the kurtosis of the entries in the specified portion of the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
Returns the arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
Returns the weighted arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
Returns the weighted arithmetic mean of the entries in the input array.
evaluate(double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
This method calculates SemiVariance for the entire array against the mean, using instance properties varianceDirection and biasCorrection.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the mean, using instance properties varianceDirection and biasCorrection.
evaluate(double[], SemiVariance.Direction) - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
This method calculates SemiVariance for the entire array against the mean, using the current value of the biasCorrection instance property.
evaluate(double[], double) - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the cutoff, using instance properties variancDirection and biasCorrection.
evaluate(double[], double, SemiVariance.Direction) - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the cutoff in the given direction, using the current value of the biasCorrection instance property.
evaluate(double[], double, SemiVariance.Direction, boolean, int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Returns the SemiVariance of the designated values against the cutoff in the given direction with the provided bias correction.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
Returns the Skewness of the entries in the specifed portion of the input array.
evaluate(double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the input array, or Double.NaN if the array is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double, int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the specified portion of the input array, using the precomputed mean value.
evaluate(double[], double) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns the Standard Deviation of the entries in the input array, using the precomputed mean value.
evaluate(double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the variance of the entries in the input array, or Double.NaN if the array is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the weighted variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the weighted variance of the entries in the the input array.
evaluate(double[], double, int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.
evaluate(double[], double) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the variance of the entries in the input array, using the precomputed mean value.
evaluate(double[], double[], double, int, int) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the weighted variance of the entries in the specified portion of the input array, using the precomputed weighted mean value.
evaluate(double[], double[], double) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the weighted variance of the values in the input array, using the precomputed weighted mean value.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.rank.Max
Returns the maximum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.rank.Min
Returns the minimum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Returns the result of evaluating the statistic over the stored data.
evaluate(double[], double) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Returns an estimate of the pth percentile of the values in the values array.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Returns an estimate of the quantileth percentile of the designated values in the values array.
evaluate(double[], int, int, double) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Returns an estimate of the pth percentile of the values in the values array, starting with the element in (0-based) position begin in the array and including length values.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.summary.Product
Returns the product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.summary.Product
Returns the weighted product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math.stat.descriptive.summary.Product
Returns the weighted product of the entries in the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
The sum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
The weighted sum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], double[]) - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
The weighted sum of the entries in the the input array.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Returns the sum of the natural logs of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Returns the sum of the squares of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
evaluate(double[]) - Method in interface org.apache.commons.math.stat.descriptive.UnivariateStatistic
Returns the result of evaluating the statistic over the input array.
evaluate(double[], int, int) - Method in interface org.apache.commons.math.stat.descriptive.UnivariateStatistic
Returns the result of evaluating the statistic over the specified entries in the input array.
evaluate(double[], double[]) - Method in interface org.apache.commons.math.stat.descriptive.WeightedEvaluation
Returns the result of evaluating the statistic over the input array, using the supplied weights.
evaluate(double[], double[], int, int) - Method in interface org.apache.commons.math.stat.descriptive.WeightedEvaluation
Returns the result of evaluating the statistic over the specified entries in the input array, using corresponding entries in the supplied weights array.
evaluate(double) - Method in class org.apache.commons.math.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, double) - Method in class org.apache.commons.math.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, int) - Method in class org.apache.commons.math.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double, double, int) - Method in class org.apache.commons.math.util.ContinuedFraction
Evaluates the continued fraction at the value x.
evaluate(double) - Method in class umontreal.iro.lecuyer.functionfit.BSpline
 
evaluate(double) - Method in class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Evaluates and returns the value of the spline at z.
evaluate(double) - Method in class umontreal.iro.lecuyer.functions.AverageMathFunction
 
evaluate(double) - Method in class umontreal.iro.lecuyer.functions.IdentityMathFunction
 
evaluate(double) - Method in interface umontreal.iro.lecuyer.functions.MathFunction
Returns the value of the function evaluated at x.
evaluate(double) - Method in class umontreal.iro.lecuyer.functions.PiecewiseConstantFunction
 
evaluate(double) - Method in class umontreal.iro.lecuyer.functions.Polynomial
 
evaluate(double) - Method in class umontreal.iro.lecuyer.functions.PowerMathFunction
 
evaluate(double) - Method in class umontreal.iro.lecuyer.functions.ShiftedMathFunction
 
evaluate(double) - Method in class umontreal.iro.lecuyer.functions.SqrtMathFunction
 
evaluate(double) - Method in class umontreal.iro.lecuyer.functions.SquareMathFunction
 
evaluate(double...) - Method in interface umontreal.iro.lecuyer.util.MultivariateFunction
Computes the function g(x) for the vector x.
evaluate(double...) - Method in class umontreal.iro.lecuyer.util.RatioFunction
 
evaluateDouble() - Method in class hep.aida.ref.tuple.Evaluator
 
evaluateGradient(int, IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.AbstractFitMethod
 
evaluateGradient(int, IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.ChiSquaredFitMethod
 
evaluateGradient(int, double...) - Method in interface umontreal.iro.lecuyer.util.MultivariateFunction
Computes g(x)/∂xi, the derivative of g(x) with respect to xi.
evaluateGradient(int, double...) - Method in class umontreal.iro.lecuyer.util.RatioFunction
 
evaluateGradientSumElement(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.BinnedMaximumLikelihoodFitMethod
 
evaluateGradientSumElement(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.ChiSquaredFitMethod
 
evaluateGradientSumElement(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.CleverChiSquaredFitMethod
 
evaluateGradientSumElement(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.LeastSquaresFitMethod
 
evaluateGradientSumElement(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.UnbinnedMaximumLikelihoodFitMethod
 
evaluateMax(IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
evaluateMax(IEvaluator, IFilter) - Method in class hep.aida.ref.tuple.AbstractTuple
 
evaluateMin(IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
evaluateMin(IEvaluator, IFilter) - Method in class hep.aida.ref.tuple.AbstractTuple
 
evaluateStep(StepInterpolator) - Method in class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Evaluate the impact of the proposed step on all managed event handlers.
evaluateStep(StepInterpolator) - Method in class org.apache.commons.math.ode.events.EventState
Evaluate the impact of the proposed step on the event handler.
evaluateSumElement(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.BinnedMaximumLikelihoodFitMethod
 
evaluateSumElement(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.ChiSquaredFitMethod
 
evaluateSumElement(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.CleverChiSquaredFitMethod
 
evaluateSumElement(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.LeastSquaresFitMethod
 
evaluateSumElement(IDevFitDataIterator, IFunction) - Method in class hep.aida.ref.fitter.fitmethod.UnbinnedMaximumLikelihoodFitMethod
 
Evaluator - Class in hep.aida.ref.tuple
 
Evaluator(String) - Constructor for class hep.aida.ref.tuple.Evaluator
Default contructor.
evalX(double) - Method in class umontreal.iro.lecuyer.functionfit.BSpline
 
evalY(double) - Method in class umontreal.iro.lecuyer.functionfit.BSpline
 
Event - Class in umontreal.iro.lecuyer.simevents
This abstract class provides event scheduling tools.
Event() - Constructor for class umontreal.iro.lecuyer.simevents.Event
Constructs a new event instance, which can be placed afterwards into the event list of the default simulator.
Event(Simulator) - Constructor for class umontreal.iro.lecuyer.simevents.Event
Construct a new event instance associated with the given simulator.
EventException - Exception in org.apache.commons.math.ode.events
This exception is made available to users to report the error conditions that are triggered by EventHandler
EventException(String, Object...) - Constructor for exception org.apache.commons.math.ode.events.EventException
Deprecated. as of 2.2 replaced by EventException.EventException(Localizable, Object...)
EventException(Localizable, Object...) - Constructor for exception org.apache.commons.math.ode.events.EventException
Simple constructor.
EventException(Throwable) - Constructor for exception org.apache.commons.math.ode.events.EventException
Create an exception with a given root cause.
EventHandler - Interface in org.apache.commons.math.ode.events
This interface represents a handler for discrete events triggered during ODE integration.
EventHandlerWithJacobians - Interface in org.apache.commons.math.ode.jacobians
Deprecated. as of 2.2 the complete package is deprecated, it will be replaced in 3.0 by a completely rewritten implementation
eventId() - Method in class hep.aida.ref.function.FunctionChangedEvent
 
EventList - Interface in umontreal.iro.lecuyer.simevents.eventlist
An interface for implementations of event lists.
eventOccurred(double, double[], boolean) - Method in interface org.apache.commons.math.ode.events.EventHandler
Handle an event and choose what to do next.
eventOccurred(double, double[], double[][], double[][], boolean) - Method in interface org.apache.commons.math.ode.jacobians.EventHandlerWithJacobians
Deprecated. Handle an event and choose what to do next.
EventState - Class in org.apache.commons.math.ode.events
This class handles the state for one event handler during integration steps.
EventState(EventHandler, double, double, int) - Constructor for class org.apache.commons.math.ode.events.EventState
Simple constructor.
evolve(Population, StoppingCondition) - Method in class org.apache.commons.math.genetics.GeneticAlgorithm
Evolve the given population.
evToNm(double) - Static method in class flanagan.math.Conv
 
evToNm(double) - Static method in class flanagan.math.Fmath
 
ExactDoubleQuantileFinder - Class in cern.jet.stat.tdouble.quantile
Exact quantile finding algorithm for known and unknown N requiring large main memory; computes quantiles over a sequence of double elements.
ExactDoubleQuantileFinder() - Constructor for class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Constructs an empty exact quantile finder.
excessCurtosis() - Method in class flanagan.analysis.Stat
 
excessCurtosis(double[]) - Static method in class flanagan.analysis.Stat
 
excessCurtosis(float[]) - Static method in class flanagan.analysis.Stat
 
excessCurtosis(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
excessCurtosis(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
excessCurtosis(long[]) - Static method in class flanagan.analysis.Stat
 
excessCurtosis(int[]) - Static method in class flanagan.analysis.Stat
 
excessCurtosis_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
excessCurtosis_as_double() - Method in class flanagan.analysis.Stat
 
excessKurtosis() - Method in class flanagan.analysis.Stat
 
excessKurtosis(double[]) - Static method in class flanagan.analysis.Stat
 
excessKurtosis(float[]) - Static method in class flanagan.analysis.Stat
 
excessKurtosis(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
excessKurtosis(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
excessKurtosis(long[]) - Static method in class flanagan.analysis.Stat
 
excessKurtosis(int[]) - Static method in class flanagan.analysis.Stat
 
excessKurtosis_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
excessKurtosis_as_double() - Method in class flanagan.analysis.Stat
 
exclude(double, double) - Method in class hep.aida.ref.function.RangeSet
 
excludeAll() - Method in class hep.aida.ref.function.RangeSet
Set empty range in all axes.
excludeNormalizationAll(int) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
excludeNormalizationAll() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
excludeNormalizationAll() - Method in class hep.aida.ref.function.AbstractIFunction
 
excludeNormalizationAll() - Method in class hep.aida.ref.function.BaseModelFunction
 
excludeNormalizationRange(double, double, int) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
EXECUTING - Static variable in class umontreal.iro.lecuyer.simprocs.SimProcess
The process is the one currently executing its actions method.
exit() - Method in class jhplot.HZirkel
 
exp - Static variable in class cern.jet.math.Functions
Function that returns Math.exp(a).
exp(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
exp - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
exp - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.exp(a).
exp(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
exp - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
exp - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.exp(a).
exp(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
exp() - Method in class flanagan.analysis.Stat
 
exp() - Method in class flanagan.math.ArrayMaths
 
exp() - Method in class jhplot.math.Complex
Complex exponential (doesn't change this Complex number).
exp(ValueErr) - Static method in class jhplot.math.ValueErr
Get exponential function
EXP - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.exp method wrapped as a ComposableFunction.
exp() - Method in class org.apache.commons.math.complex.Complex
Compute the exponential function of this complex number.
exp(Dfp) - Static method in class org.apache.commons.math.dfp.DfpMath
Computes e to the given power.
exp(double) - Static method in class org.apache.commons.math.util.FastMath
Exponential function.
expBesselK1(double, double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of exK1(y), where K1 is the modified Bessel function of the second kind of order 1.
ExpData - Class in jhpro.stat.limit
Build experiment.
ExpData() - Constructor for class jhpro.stat.limit.ExpData
Simple constructor
ExpData(int, double, double) - Constructor for class jhpro.stat.limit.ExpData
Build an experiment
ExpData(int, double, double, double, double) - Constructor for class jhpro.stat.limit.ExpData
Build an experimental data
EXPM1 - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.expm1 method wrapped as a ComposableFunction.
expm1(double) - Static method in class org.apache.commons.math.util.FastMath
Compute exp(x) - 1
Exponent - Class in jhplot.fit
Exponential distribution.
Exponent() - Constructor for class jhplot.fit.Exponent
 
Exponent(String) - Constructor for class jhplot.fit.Exponent
 
Exponent(String[], String[]) - Constructor for class jhplot.fit.Exponent
 
Exponent - Static variable in class jhplot.HPlotJa
 
Exponential - Class in cern.jet.random
Exponential Distribution (aka Negative Exponential Distribution); See the math definition animated definition.
Exponential(double, RandomEngine) - Constructor for class cern.jet.random.Exponential
Constructs a Negative Exponential distribution.
Exponential - Class in cern.jet.random.tdouble
Exponential Distribution (aka Negative Exponential Distribution); See the math definition animated definition.
Exponential(double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.Exponential
Constructs a Negative Exponential distribution.
exponential() - Method in class flanagan.analysis.Regression
 
exponential(double, double, double) - Static method in class flanagan.analysis.Stat
 
Exponential - Class in jhplot.math.num.pdf
The Exponential distribution (1).
Exponential() - Constructor for class jhplot.math.num.pdf.Exponential
Default constructor.
Exponential(double) - Constructor for class jhplot.math.num.pdf.Exponential
Create a distribution with the given mean.
exponential(double) - Static method in class jhplot.math.Random
Generate a random number from an exponantial random variable (Mean = 1/lambda, variance = 1/lambda^2).
EXPONENTIAL_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Exponential random deviates with mean = μ.
exponentialArray(double, double, int) - Method in class flanagan.math.PsRandom
 
exponentialCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
exponentialCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
ExponentialCoreNorm - Class in hep.aida.ref.function
Normalised Exponential (E) distribution in the form: f = (1/N)*exp((x-origin)/exponent)) has 2 parameters, Normalization Amplitude N is calculated by the "normalizationAmplitude" method
ExponentialCoreNorm(String) - Constructor for class hep.aida.ref.function.ExponentialCoreNorm
 
ExponentialCoreNorm(String, double[]) - Constructor for class hep.aida.ref.function.ExponentialCoreNorm
 
ExponentialCoreNotNorm - Class in hep.aida.ref.function
Not normalised Exponential (E) distribution in the form: f = amplitude*exp((x-origin)/exponent) has 3 parameters
ExponentialCoreNotNorm(String) - Constructor for class hep.aida.ref.function.ExponentialCoreNotNorm
 
ExponentialCoreNotNorm(String, double[]) - Constructor for class hep.aida.ref.function.ExponentialCoreNotNorm
 
exponentialCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
ExponentialDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the exponential distribution with mean 1/λ where λ > 0.
ExponentialDist() - Constructor for class umontreal.iro.lecuyer.probdist.ExponentialDist
Constructs an ExponentialDist object with parameter λ = 1.
ExponentialDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.ExponentialDist
Constructs an ExponentialDist object with parameter λ = lambda.
ExponentialDistFromMean - Class in umontreal.iro.lecuyer.probdist
Extends the ExponentialDist class with a constructor accepting as argument the mean 1/λ instead of the rate λ.
ExponentialDistFromMean(double) - Constructor for class umontreal.iro.lecuyer.probdist.ExponentialDistFromMean
Constructs a new exponential distribution with mean mean.
ExponentialDistribution - Interface in org.apache.commons.math.distribution
The Exponential Distribution.
ExponentialDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of ExponentialDistribution.
ExponentialDistributionImpl(double) - Constructor for class org.apache.commons.math.distribution.ExponentialDistributionImpl
Create a exponential distribution with the given mean.
ExponentialDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.ExponentialDistributionImpl
Create a exponential distribution with the given mean.
ExponentialGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the exponential distribution.
ExponentialGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.ExponentialGen
Creates an exponential random variate generator with parameter λ = lambda, using stream s.
ExponentialGen(RandomStream, ExponentialDist) - Constructor for class umontreal.iro.lecuyer.randvar.ExponentialGen
Creates a new generator for the exponential distribution dist and stream s.
exponentialGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
exponentialGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
exponentialIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
exponentialInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
exponentialInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
exponentialMean(double, double) - Static method in class flanagan.analysis.Stat
 
exponentialMedian(double, double) - Static method in class flanagan.analysis.Stat
 
exponentialMode(double) - Static method in class flanagan.analysis.Stat
 
exponentialMu() - Method in class flanagan.analysis.ProbabilityPlot
 
exponentialMuError() - Method in class flanagan.analysis.ProbabilityPlot
 
exponentialMultiple(int) - Method in class flanagan.analysis.Regression
 
exponentialMultiple(int, double[]) - Method in class flanagan.analysis.Regression
 
exponentialMultiplePlot(int) - Method in class flanagan.analysis.Regression
 
exponentialMultiplePlot(int, double[]) - Method in class flanagan.analysis.Regression
 
exponentialOnePar() - Method in class flanagan.analysis.Regression
 
exponentialOneParPlot() - Method in class flanagan.analysis.Regression
 
exponentialOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
exponentialOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
exponentialPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
exponentialPlot() - Method in class flanagan.analysis.Regression
 
ExponentialPower - Class in cern.jet.random
Exponential Power distribution.
ExponentialPower(double, RandomEngine) - Constructor for class cern.jet.random.ExponentialPower
Constructs an Exponential Power distribution.
ExponentialPower - Class in cern.jet.random.tdouble
Exponential Power distribution.
ExponentialPower(double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.ExponentialPower
Constructs an Exponential Power distribution.
exponentialProb(double, double, double) - Static method in class flanagan.analysis.Stat
 
exponentialProb(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
exponentialProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
exponentialRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
exponentialRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
ExponentialRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Exponential distribution.
ExponentialRandomVariable() - Constructor for class jhplot.math.num.random.ExponentialRandomVariable
Default constructor.
ExponentialRandomVariable(double) - Constructor for class jhplot.math.num.random.ExponentialRandomVariable
Create a random variable with the given mean.
ExponentialRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.ExponentialRandomVariable
Create a random variable with the given parameters.
exponentialSigma() - Method in class flanagan.analysis.ProbabilityPlot
 
exponentialSigmaError() - Method in class flanagan.analysis.ProbabilityPlot
 
exponentialSimple() - Method in class flanagan.analysis.Regression
 
exponentialSimplePlot() - Method in class flanagan.analysis.Regression
 
exponentialStandard() - Method in class flanagan.analysis.Regression
 
exponentialStandardDeviation(double) - Static method in class flanagan.analysis.Stat
 
exponentialStandardPlot() - Method in class flanagan.analysis.Regression
 
exponentialStandDev(double) - Static method in class flanagan.analysis.Stat
 
exponentialSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
ExponentModelFunction - Class in hep.aida.ref.function
 
ExponentModelFunction(String) - Constructor for class hep.aida.ref.function.ExponentModelFunction
 
export(String) - Method in class jhplot.GHPanel
Fast export of the canvas to an image file (depends on the extension, i.e.
export(String) - Method in class jhplot.HPlotJa
Fast export of the canvas to an image file (depends on the extension, i.e.
export(String) - Method in class jhplot.HZirkel
Export image to a file.
export(String) - Method in class jhplot.SPlot
Fast export of the canvas to an image file (depends on the extension, i.e.
exportDialog(String) - Method in class jhplot.GHPanel
Export a GHFrame image to an external file: The file extension is very important: *.png - make PNG figure *.eps - make EPS figure *.ps - make PS figure *.jpg - make JPG figure *.pdf - make PDF figure *.SVG - make SVG figure *.EMF - make EMF figure, It will open some dialog in case if the file exists
exportImage() - Method in class jhplot.GHPanel
Exports the image to some graphic format.
expression() - Method in class hep.aida.ref.fitter.fitdata.RangeSetFilter
 
expression() - Method in class hep.aida.ref.tuple.Evaluator
 
expression() - Method in class hep.aida.ref.tuple.Filter
 
exsec(double) - Static method in class flanagan.math.Fmath
 
ExtendedFirstOrderDifferentialEquations - Interface in org.apache.commons.math.ode
This interface represents a first order differential equations set with a main set of equations and an extension set.
extendSequence(int) - Method in class umontreal.iro.lecuyer.hups.DigitalSequence
Increases the number of points to n = bk from now on.
extendSequence(int) - Method in class umontreal.iro.lecuyer.hups.DigitalSequenceBase2
Increases the number of points to n = 2k from now on.
extendSequence(int) - Method in class umontreal.iro.lecuyer.hups.FaureSequence
 
extendSequence(int) - Method in class umontreal.iro.lecuyer.hups.NiedSequenceBase2
 
extendSequence(int) - Method in class umontreal.iro.lecuyer.hups.NiedXingSequenceBase2
 
extendSequence(int) - Method in class umontreal.iro.lecuyer.hups.SobolSequence
 
extract(int, int, double[]) - Static method in class jhplot.math.ArrayMathUtils
Extracts a sub-array (will invert the resulting array if k0 > k1).
extract(int, int, int[]) - Static method in class jhplot.math.ArrayMathUtils
Extracts a sub-array (will invert the resulting array if k0 > k1).
extraEntries() - Method in class hep.aida.ref.histogram.Histogram
Get the number of entries in the underflow and overflow bins.
extraEntries() - Method in class hep.aida.ref.histogram.Histogram1D
Get the number of entries in the underflow and overflow bins.
extraEntries() - Method in class hep.aida.ref.histogram.Histogram2D
Get the number of entries in the underflow and overflow bins.
extraEntries() - Method in class hep.aida.ref.histogram.Histogram3D
Get the number of entries in the underflow and overflow bins.
extraEntries() - Method in class hep.aida.ref.histogram.Profile1D
 
extraEntries() - Method in class hep.aida.ref.histogram.Profile2D
 
extraEntries() - Method in interface hep.aida.tdouble.DoubleIHistogram
Number of under and overflow entries in the histogram.
extraEntries() - Method in interface hep.aida.tfloat.FloatIHistogram
Number of under and overflow entries in the histogram.
extraEntries() - Method in class jhplot.H1D
Number of under and overflow entries in the histogram.
extraEntries() - Method in class jhplot.H2D
Get the number of entries in the underflow and overflow bins.
extraEntries() - Method in class jhplot.HProf1D
Number of under and overflow entries in the histogram.
extraEntries() - Method in class jhplot.HProf2D
Get the number of entries in the underflow and overflow bins.
ExtremeValueDist - Class in umontreal.iro.lecuyer.probdist
Deprecated. 
ExtremeValueDist() - Constructor for class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. THIS CLASS HAS BEEN REPLACED BY GumbelDist.
ExtremeValueDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. THIS CLASS HAS BEEN REPLACED BY GumbelDist.
ExtremeValueGen - Class in umontreal.iro.lecuyer.randvar
Deprecated. 
ExtremeValueGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.ExtremeValueGen
Deprecated. Creates an extreme value random variate generator with parameters α = alpha and λ = lambda, using stream s.
ExtremeValueGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.ExtremeValueGen
Deprecated. Creates an extreme value random variate generator with parameters α = 0 and λ = 1, using stream s.
ExtremeValueGen(RandomStream, ExtremeValueDist) - Constructor for class umontreal.iro.lecuyer.randvar.ExtremeValueGen
Deprecated. Creates a new generator object for distribution dist and stream s.

F

f(double[][], Function) - Static method in class jhplot.math.DoubleArray
Apply a scalar function to every element of an array.
f(double[], Function) - Static method in class jhplot.math.DoubleArray
Apply a scalar function to every element of an array.
f(double) - Method in interface jhplot.math.Function
 
f(double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as f (0, 6, x).
f(int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as f (fieldwidth, 6, x).
f(int, int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Formats the double-precision x into a string like %f in C printf.
F1D - Class in jhplot
Create a function in 1D.
F1D(String, double, double) - Constructor for class jhplot.F1D
Create a function in 1D.
F1D(String, double, double, boolean) - Constructor for class jhplot.F1D
Same function, but one can specify is it parsed or not.
F1D(String) - Constructor for class jhplot.F1D
Create a function in 1D for evaluation.
F1D(String, String) - Constructor for class jhplot.F1D
Create new function.
F1D(String, String, double, double, boolean) - Constructor for class jhplot.F1D
Create a new function.
F1D(String, double[], double, double, boolean) - Constructor for class jhplot.F1D
Create a polynomial analytical function using a list of values.
F1D(String, boolean) - Constructor for class jhplot.F1D
Build a function
F1D(String, ParseFunction, double, double) - Constructor for class jhplot.F1D
Create a function in 1D.
F1D(ParseFunction, double, double) - Constructor for class jhplot.F1D
Build a function.
F1D(String, String, double, double) - Constructor for class jhplot.F1D
Create a function in 1D.
F1D(IFunction, double, double) - Constructor for class jhplot.F1D
Create a F1D function from JAIDA IFunction.
F1D(IFunction) - Constructor for class jhplot.F1D
Create a F1D function from JAIDA IFunction.
F1D(String, IFunction, double, double) - Constructor for class jhplot.F1D
Create F1D function from JAIDA IFunction.
F2D - Class in jhplot
Create 2D function.
F2D(String) - Constructor for class jhplot.F2D
Create a function in 2D for evaluation.
F2D(String, String, double, double, double, double) - Constructor for class jhplot.F2D
Create a function in 2D.
F2D(String, double, double, double, double) - Constructor for class jhplot.F2D
Build a 2D function.
F2D(String, IFunction, double, double, double, double) - Constructor for class jhplot.F2D
Create a F2D function from JAIDA IFunction.
F2D(IFunction) - Constructor for class jhplot.F2D
Create a F2D function from JAIDA IFunction.
F2D(IFunction, double, double, double, double) - Constructor for class jhplot.F2D
Create a F2D function from JAIDA IFunction.
F2NL607 - Class in umontreal.iro.lecuyer.rng
Implements the RandomStream interface by using as a backbone generator the combination of the WELL607 proposed in (and implemented in WELL607) with a nonlinear generator.
F2NL607() - Constructor for class umontreal.iro.lecuyer.rng.F2NL607
Constructs a new stream, initializing it at its beginning.
F2NL607(String) - Constructor for class umontreal.iro.lecuyer.rng.F2NL607
Constructs a new stream with the identifier name (used in the toString method).
F2wCycleBasedLFSR - Class in umontreal.iro.lecuyer.hups
This class creates a point set based upon a linear feedback shift register sequence.
F2wCycleBasedLFSR(int, int, int, int, int, int[], int[]) - Constructor for class umontreal.iro.lecuyer.hups.F2wCycleBasedLFSR
Constructs a point set with 2rw points.
F2wCycleBasedLFSR(String, int) - Constructor for class umontreal.iro.lecuyer.hups.F2wCycleBasedLFSR
Constructs a point set after reading its parameters from file filename; the parameters are located at line numbered no of filename.
F2wCycleBasedPolyLCG - Class in umontreal.iro.lecuyer.hups
This class creates a point set based upon a linear congruential sequence in the finite field F2w[z]/P(z).
F2wCycleBasedPolyLCG(int, int, int, int, int, int[], int[]) - Constructor for class umontreal.iro.lecuyer.hups.F2wCycleBasedPolyLCG
Constructs a point set with 2rw points.
F2wCycleBasedPolyLCG(String, int) - Constructor for class umontreal.iro.lecuyer.hups.F2wCycleBasedPolyLCG
Constructs a point set after reading its parameters from file filename; the parameters are located at line numbered no of filename.
F2wNetLFSR - Class in umontreal.iro.lecuyer.hups
This class implements a digital net in base 2 starting from a linear feedback shift register generator.
F2wNetLFSR(int, int, int, int, int, int[], int[], int) - Constructor for class umontreal.iro.lecuyer.hups.F2wNetLFSR
Constructs a point set with 2rw points.
F2wNetLFSR(String, int, int) - Constructor for class umontreal.iro.lecuyer.hups.F2wNetLFSR
Constructs a point set after reading its parameters from file filename; the parameters are located at line numbered no of filename.
F2wNetPolyLCG - Class in umontreal.iro.lecuyer.hups
This class implements a digital net in base 2 starting from a polynomial LCG in F2w[z]/P(z).
F2wNetPolyLCG(int, int, int, int, int, int, int[], int[], int) - Constructor for class umontreal.iro.lecuyer.hups.F2wNetPolyLCG
Constructs a point set with 2rw points.
F2wNetPolyLCG(String, int, int) - Constructor for class umontreal.iro.lecuyer.hups.F2wNetPolyLCG
Constructs a point set after reading its parameters from file filename; the parameters are located at line numbered no of filename.
F2wStructure - Class in umontreal.iro.lecuyer.hups
This class implements methods and fields needed by the classes F2wNetLFSR, F2wNetPolyLCG, F2wCycleBasedLFSR and F2wCycleBasedPolyLCG.
F3D - Class in jhplot
Create 3D function.
F3D(String) - Constructor for class jhplot.F3D
Create a function in 3D for evaluation.
F3D(String, String, double, double, double, double, double, double) - Constructor for class jhplot.F3D
Create a function in 3D.
F3D(String, double, double, double, double, double, double) - Constructor for class jhplot.F3D
Build a 3D function.
F3D(String, String, IFunction, double, double, double, double, double, double) - Constructor for class jhplot.F3D
Create a function in 3D from a AIDA IFunction.
F3D(String, IFunction, double, double, double, double, double, double) - Constructor for class jhplot.F3D
 
F3D(IFunction, double, double, double, double, double, double) - Constructor for class jhplot.F3D
Create a function in 3D from a AIDA IFunction.
F_FARADAY - Static variable in class flanagan.math.Fmath
 
factorial(int) - Static method in class cern.jet.math.Arithmetic
Instantly returns the factorial k!.
factorial - Static variable in class cern.jet.math.IntFunctions
Function that returns (int) Arithmetic.factorial(a).
factorial(int) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Instantly returns the factorial k!.
factorial(long) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Instantly returns the factorial k!.
factorial(int) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Instantly returns the factorial k!.
factorial - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns (int) Arithmetic.factorial(a).
factorial - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns (long) Arithmetic.factorial(a).
factorial(int) - Static method in class flanagan.analysis.Stat
 
factorial(long) - Static method in class flanagan.analysis.Stat
 
factorial(BigInteger) - Static method in class flanagan.analysis.Stat
 
factorial(double) - Static method in class flanagan.analysis.Stat
 
factorial(BigDecimal) - Static method in class flanagan.analysis.Stat
 
factorial(int) - Static method in class flanagan.math.Fmath
 
factorial(long) - Static method in class flanagan.math.Fmath
 
factorial(BigInteger) - Static method in class flanagan.math.Fmath
 
factorial(double) - Static method in class flanagan.math.Fmath
 
factorial(BigDecimal) - Static method in class flanagan.math.Fmath
 
factorial(int) - Static method in class org.apache.commons.math.util.MathUtils
Returns n!.
factorial(int) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of factorial n.
factorialDouble(int) - Static method in class org.apache.commons.math.util.MathUtils
Returns n!.
factorialLog(int) - Static method in class org.apache.commons.math.util.MathUtils
Returns the natural logarithm of n!.
FactorialMoments - Class in jhplot.stat
**************************************************************************** Calculations of normalized factorial moments characterizing local multiplicity fluctuations inside a restricted phase space.
FactorialMoments(int, int, int, double, double) - Constructor for class jhplot.stat.FactorialMoments
Initialize factorial-moment calculations.
factories() - Method in class jhplot.HPlot
Create various JAIDA factories: IAnalysisFactory, ITree, IFitFactory, IFunctionFactory
factories() - Method in class jhplot.HPlotJa
Create various JAIDA factories: IAnalysisFactory, ITree, IFitFactory, IFunctionFactory
fahrenToCelsius(double) - Static method in class flanagan.math.Conv
 
fahrenToCelsius(double) - Static method in class flanagan.math.Fmath
 
FalsePositionRootFinder - Class in jhplot.math.num.root
The false position method (1) for finding roots of functions.
FalsePositionRootFinder(Function) - Constructor for class jhplot.math.num.root.FalsePositionRootFinder
Create a root finder for the given function.
FalsePositionRootFinder(Function, int, double) - Constructor for class jhplot.math.num.root.FalsePositionRootFinder
Create a root finder for the given function.
farad - Static variable in class cern.clhep.Units
 
FArc(float, float, float, float, float, float) - Static method in class jhplot.jadraw.Diagram
 
fArray(int, int, int) - Method in class flanagan.math.PsRandom
 
FastCosineTransformer - Class in org.apache.commons.math.transform
Implements the Fast Cosine Transform for transformation of one-dimensional data sets.
FastCosineTransformer() - Constructor for class org.apache.commons.math.transform.FastCosineTransformer
Construct a default transformer.
FastFourierTransformer - Class in org.apache.commons.math.transform
Implements the Fast Fourier Transform for transformation of one-dimensional data sets.
FastFourierTransformer() - Constructor for class org.apache.commons.math.transform.FastFourierTransformer
Construct a default transformer.
FastHadamardTransformer - Class in org.apache.commons.math.transform
Implements the Fast Hadamard Transform (FHT).
FastHadamardTransformer() - Constructor for class org.apache.commons.math.transform.FastHadamardTransformer
 
FastMath - Class in org.apache.commons.math.util
Faster, more accurate, portable alternative to StrictMath.
FastSineTransformer - Class in org.apache.commons.math.transform
Implements the Fast Sine Transform for transformation of one-dimensional data sets.
FastSineTransformer() - Constructor for class org.apache.commons.math.transform.FastSineTransformer
Construct a default transformer.
fathersDay() - Method in class flanagan.math.TimeAndDate
 
fathersDay(int) - Method in class flanagan.math.TimeAndDate
 
FatigueLifeDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the fatigue life distribution with location parameter μ, scale parameter β and shape parameter γ.
FatigueLifeDist(double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Constructs a fatigue life distribution with parameters μ, β and γ.
FatigueLifeGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the fatigue life distribution with location parameter μ, scale parameter β and shape parameter γ.
FatigueLifeGen(RandomStream, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.FatigueLifeGen
Creates a fatigue life random variate generator with parameters μ = mu, β = beta and γ = gamma, using stream s.
FatigueLifeGen(RandomStream, FatigueLifeDist) - Constructor for class umontreal.iro.lecuyer.randvar.FatigueLifeGen
Creates a new generator for the distribution dist, using stream s.
FaureSequence - Class in umontreal.iro.lecuyer.hups
This class implements digital nets or digital sequences formed by the first n = bk points of the Faure sequence in base b.
FaureSequence(int, int, int, int, int) - Constructor for class umontreal.iro.lecuyer.hups.FaureSequence
Constructs a digital net in base b, with n = bk points and w output digits, in dim dimensions.
FaureSequence(int, int) - Constructor for class umontreal.iro.lecuyer.hups.FaureSequence
Same as FaureSequence(b, k, w, w, dim) with base b equal to the smallest prime larger or equal to dim, and with at least n points.
fbar(int, double) - Static method in class jhplot.math.KolmogorovSmirnovDist
Computes the complementary cumulative probability P[D_n >= x] of the Kolmogorov-Smirnov distribution with sample size n at x.
FBar - Class in umontreal.iro.lecuyer.gof
This class is similar to FDist, except that it provides static methods to compute or approximate the complementary distribution function of X, which we define as bar(F)(x) = P[X >= x], instead of F(x) = P[X <= x].
fCompCDF(double, int, int) - Static method in class flanagan.analysis.Stat
 
fCompCDF(double, int, double, int) - Static method in class flanagan.analysis.Stat
 
FComplex - Class in cern.jet.math.tfcomplex
Complex arithmetic
FComplexFactory1D - Class in cern.colt.matrix.tfcomplex
Factory for convenient construction of 1-d matrices holding complex cells.
FComplexFactory2D - Class in cern.colt.matrix.tfcomplex
Factory for convenient construction of 2-d matrices holding complex cells.
FComplexFactory3D - Class in cern.colt.matrix.tfcomplex
Factory for convenient construction of 3-d matrices holding complex cells.
FComplexFComplexFComplexFunction - Interface in cern.colt.function.tfcomplex
 
FComplexFComplexFunction - Interface in cern.colt.function.tfcomplex
 
FComplexFComplexProcedure - Interface in cern.colt.function.tfcomplex
 
FComplexFComplexRealFunction - Interface in cern.colt.function.tfcomplex
 
FComplexFComplexRealProcedure - Interface in cern.colt.function.tfcomplex
 
FComplexFComplexRealRealFunction - Interface in cern.colt.function.tfcomplex
 
FComplexFunctions - Class in cern.jet.math.tfcomplex
Complex function objects to be passed to generic methods.
FComplexFunctions() - Constructor for class cern.jet.math.tfcomplex.FComplexFunctions
 
FComplexMatrix1D - Class in cern.colt.matrix.tfcomplex
Abstract base class for 1-d matrices (aka vectors) holding complex elements.
FComplexMatrix1DProcedure - Interface in cern.colt.matrix.tfcomplex
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
FComplexMatrix2D - Class in cern.colt.matrix.tfcomplex
Abstract base class for 2-d matrices holding complex elements.
FComplexMatrix2DProcedure - Interface in cern.colt.matrix.tfcomplex
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
FComplexMatrix3D - Class in cern.colt.matrix.tfcomplex
Abstract base class for 3-d matrices holding complex elements.
FComplexMult - Class in cern.jet.math.tfcomplex
Only for performance tuning of compute intensive linear algebraic computations.
FComplexPlusMultFirst - Class in cern.jet.math.tfcomplex
Only for performance tuning of compute intensive linear algebraic computations.
FComplexPlusMultSecond - Class in cern.jet.math.tfcomplex
Only for performance tuning of compute intensive linear algebraic computations.
FComplexProcedure - Interface in cern.colt.function.tfcomplex
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
FComplexProperty - Class in cern.colt.matrix.tfcomplex.algo
Tests matrices for equality.
FComplexProperty(float) - Constructor for class cern.colt.matrix.tfcomplex.algo.FComplexProperty
Constructs an instance with a tolerance of Math.abs(newTolerance).
FComplexRealFComplexFunction - Interface in cern.colt.function.tfcomplex
 
FComplexRealFunction - Interface in cern.colt.function.tfcomplex
 
FDist - Class in umontreal.iro.lecuyer.gof
This class provides methods to compute (or approximate) the distribution functions of special types of goodness-of-fit test statistics.
FDistribution - Class in jhplot.math.num.pdf
The F distribution (1).
FDistribution() - Constructor for class jhplot.math.num.pdf.FDistribution
Default constructor.
FDistribution(double, double) - Constructor for class jhplot.math.num.pdf.FDistribution
Create a distribution with the given numerator degrees of freedom and denominator degrees of freedom.
FDistribution - Interface in org.apache.commons.math.distribution
F-Distribution.
fDistributionCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
fDistributionGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
fDistributionGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
FDistributionImpl - Class in org.apache.commons.math.distribution
Default implementation of FDistribution.
FDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.FDistributionImpl
Create a F distribution using the given degrees of freedom.
FDistributionImpl(double, double, double) - Constructor for class org.apache.commons.math.distribution.FDistributionImpl
Create a F distribution using the given degrees of freedom and inverse cumulative probability accuracy.
fDistributionIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
fDistributionInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
fDistributionInverseCDF(int, int, double) - Static method in class flanagan.analysis.Stat
 
fDistributionOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
fDistributionOrderStatisticMedians(int, int, int) - Static method in class flanagan.analysis.Stat
 
fDistributionProbabilityPlot(int, int) - Method in class flanagan.analysis.ProbabilityPlot
 
fDistributionSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
fehlberg(DerivFunction) - Method in class flanagan.integration.RungeKutta
 
fehlberg(DerivFunction, double, double, double, double, double, double, int) - Static method in class flanagan.integration.RungeKutta
 
fehlberg(DerivFunction, double, double, double, double, double, double) - Static method in class flanagan.integration.RungeKutta
 
fehlberg(DerivnFunction) - Method in class flanagan.integration.RungeKutta
 
fehlberg(DerivnFunction, double, double[], double, double, double, double, int) - Static method in class flanagan.integration.RungeKutta
 
fehlberg(DerivnFunction, double, double[], double, double, double, double) - Static method in class flanagan.integration.RungeKutta
 
fermi - Static variable in class cern.clhep.Units
 
fft() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
Computes the discrete Fourier transform (DFT) of this matrix.
fft() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Computes the discrete Fourier transform (DFT) of this matrix.
fft() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
Computes the discrete Fourier transform (DFT) of this matrix.
fft() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Computes the discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the 2D discrete Fourier transform (DFT) of this matrix.
fft2Slices() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
Computes the 2D discrete Fourier transform (DFT) of each slice of this matrix.
fft2Slices() - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix3D
Computes the 2D discrete Fourier transform (DFT) of each slice of this matrix.
fft2Slices() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
Computes the 2D discrete Fourier transform (DFT) of each slice of this matrix.
fft2Slices() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
Computes the 2D discrete Fourier transform (DFT) of each slice of this matrix.
fft2Slices() - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix3D
Computes the 2D discrete Fourier transform (DFT) of each slice of this matrix.
fft2Slices() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
Computes the 2D discrete Fourier transform (DFT) of each slice of this matrix.
fft3() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fft3() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 3D discrete Fourier transform (DFT) of this matrix.
fftColumns() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each column of this matrix.
fftColumns() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each column of this matrix.
fftColumns() - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each column of this matrix.
fftColumns() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each column of this matrix.
fftColumns() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each column of this matrix.
fftColumns() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each column of this matrix.
fftColumns() - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each column of this matrix.
fftColumns() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each column of this matrix.
fftRows() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each row of this matrix.
fftRows() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each row of this matrix.
fftRows() - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each row of this matrix.
fftRows() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each row of this matrix.
fftRows() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each row of this matrix.
fftRows() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each row of this matrix.
fftRows() - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each row of this matrix.
fftRows() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
Computes the discrete Fourier transform (DFT) of each row of this matrix.
fi(int) - Method in interface jhplot.math.IndexFunction
 
Field<T> - Interface in org.apache.commons.math
Interface representing a field.
FieldDecompositionSolver<T extends FieldElement<T>> - Interface in org.apache.commons.math.linear
Interface handling decomposition algorithms that can solve A × X = B.
FieldElement<T> - Interface in org.apache.commons.math
Interface representing field elements.
FieldLUDecomposition<T extends FieldElement<T>> - Interface in org.apache.commons.math.linear
An interface to classes that implement an algorithm to calculate the LU-decomposition of a real matrix.
FieldLUDecompositionImpl<T extends FieldElement<T>> - Class in org.apache.commons.math.linear
Calculates the LUP-decomposition of a square matrix.
FieldLUDecompositionImpl(FieldMatrix<T>) - Constructor for class org.apache.commons.math.linear.FieldLUDecompositionImpl
Calculates the LU-decomposition of the given matrix.
FieldMatrix<T extends FieldElement<T>> - Interface in org.apache.commons.math.linear
Interface defining field-valued matrix with basic algebraic operations.
FieldMatrixChangingVisitor<T extends FieldElement<?>> - Interface in org.apache.commons.math.linear
Interface defining a visitor for matrix entries.
FieldMatrixPreservingVisitor<T extends FieldElement<?>> - Interface in org.apache.commons.math.linear
Interface defining a visitor for matrix entries.
FieldVector<T extends FieldElement<T>> - Interface in org.apache.commons.math.linear
Interface defining a field-valued vector with basic algebraic operations.
FileAida - Class in jhplot.io
Open an AIDA file and retrieve objects for plotting.
FileAida(String) - Constructor for class jhplot.io.FileAida
Create object to read AIDA file.
FileAida(String, boolean) - Constructor for class jhplot.io.FileAida
Create object to read AIDA file.
FileAida() - Constructor for class jhplot.io.FileAida
Create FileAida
fileNameOfPath(String) - Static method in class jhplot.v3d.Util
 
FilePrintable - Interface in jhplot.math.io
BSD License
FileRoot - Class in jhplot.io
Class to read ROOT files.
FileRoot(String) - Constructor for class jhplot.io.FileRoot
Main constructor to build root file reader.
FileRoot(URL) - Constructor for class jhplot.io.FileRoot
Open file from URL
fill(double) - Method in class cern.hep.aida.ref.Histogram1D
 
fill(double, double) - Method in class cern.hep.aida.ref.Histogram1D
 
fill(double, double) - Method in class cern.hep.aida.ref.Histogram2D
 
fill(double, double, double) - Method in class cern.hep.aida.ref.Histogram2D
 
fill(double, double, double) - Method in class cern.hep.aida.ref.Histogram3D
 
fill(double, double, double, double) - Method in class cern.hep.aida.ref.Histogram3D
 
fill(int[], double[], double) - Method in interface hep.aida.ref.dataset.binner.Binner
Fill a bin with a new entry.
fill(int[], double[], double) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Fill a bin with a new entry.
fill(IHistogram1D, IFunction, int, double) - Static method in class hep.aida.ref.function.FunctionUtils
Fills IHistogram1D with random entries according to the provided distribution.
fill(IHistogram2D, IFunction, int, double) - Static method in class hep.aida.ref.function.FunctionUtils
 
fill(IHistogram3D, IFunction, int, double) - Static method in class hep.aida.ref.function.FunctionUtils
 
fill(int, double, double) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
fill(int, int, double, double, double) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
fill(int, int, int, double, double, double, double) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
fill(int, double, double) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
fill(int, int, double, double, double) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
fill(int, int, int, double, double, double, double) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
fill(int, double, double) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner1D
 
fill(int, int, double, double, double) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
fill(int, int, int, double, double, double, double) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
fill(double) - Method in class hep.aida.ref.histogram.Cloud1D
Fill the Cloud with a new value with unit weight
fill(double, double) - Method in class hep.aida.ref.histogram.Cloud1D
Fill the Cloud with a new value with given weight
fill(double, double) - Method in class hep.aida.ref.histogram.Cloud2D
Fill the Cloud with new values with unit weight
fill(double, double, double) - Method in class hep.aida.ref.histogram.Cloud2D
Fill the Cloud with new values with given weight
fill(double, double, double) - Method in class hep.aida.ref.histogram.Cloud3D
Fill the Cloud with new values with unit weight
fill(double, double, double, double) - Method in class hep.aida.ref.histogram.Cloud3D
Fill the Cloud with new values with given weight
fill(double) - Method in class hep.aida.ref.histogram.Histogram1D
Fill the Histogram with unit weight.
fill(double, double) - Method in class hep.aida.ref.histogram.Histogram1D
Fill the Histogram.
fill(double, double) - Method in class hep.aida.ref.histogram.Histogram2D
Fill the Histogram with unit weight.
fill(double, double, double) - Method in class hep.aida.ref.histogram.Histogram2D
Fill the Histogram.
fill(double, double, double) - Method in class hep.aida.ref.histogram.Histogram3D
Fill the Histogram with unit weight.
fill(double, double, double, double) - Method in class hep.aida.ref.histogram.Histogram3D
Fill the Histogram.
fill(double, double, double) - Method in class hep.aida.ref.histogram.Profile1D
 
fill(double, double) - Method in class hep.aida.ref.histogram.Profile1D
 
fill(double, double, double) - Method in class hep.aida.ref.histogram.Profile2D
 
fill(double, double, double, double) - Method in class hep.aida.ref.histogram.Profile2D
 
fill(boolean) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BooleanTupleColumn
 
fill(byte) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ByteTupleColumn
 
fill(char) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.CharTupleColumn
 
fill(double) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.DoubleTupleColumn
 
fill(float) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.FloatTupleColumn
 
fill(int) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.IntTupleColumn
 
fill(ITuple) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ITupleTupleColumn
 
fill(long) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.LongTupleColumn
 
fill(Object) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ObjectTupleColumn
 
fill(short) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ShortTupleColumn
 
fill(String) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.StringTupleColumn
 
fill(int, Value) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(double[]) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(float[]) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, boolean) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, byte) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, char) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, double) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, float) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, Object) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, String) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, long) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, short) - Method in class hep.aida.ref.tuple.AbstractTuple
 
fill(int, Value) - Method in class hep.aida.ref.tuple.ReadOnlyAbstractTuple
 
fill(int, Value) - Method in class hep.aida.ref.tuple.Tuple
 
fill(Value) - Method in class hep.aida.ref.tuple.TupleColumn
 
fill(boolean) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnBoolean
 
fill(byte) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnByte
 
fill(char) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnChar
 
fill(double) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnDouble
 
fill(float) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFloat
 
fill(Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
fill(ITuple) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
fill(int) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnInt
 
fill(long) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnLong
 
fill(Object) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnObject
 
fill(short) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnShort
 
fill(String) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnString
 
fill(double) - Method in interface hep.aida.tdouble.DoubleIHistogram1D
Fill histogram with weight 1.
fill(double, double) - Method in interface hep.aida.tdouble.DoubleIHistogram1D
Fill histogram with specified weight.
fill(double, double) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Fill the histogram with weight 1.
fill(double, double, double) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Fill the histogram with specified weight.
fill(double, double, double) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Fill the histogram with weight 1; equivalent to fill(x,y,z,1)..
fill(double, double, double, double) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Fill the histogram with specified weight.
fill(double) - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
fill(double, double) - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
fill(double, double) - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
fill(double, double, double) - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
fill(double, double, double) - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
fill(double, double, double, double) - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
fill(float) - Method in interface hep.aida.tfloat.FloatIHistogram1D
Fill histogram with weight 1.
fill(float, float) - Method in interface hep.aida.tfloat.FloatIHistogram1D
Fill histogram with specified weight.
fill(float, float) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Fill the histogram with weight 1.
fill(float, float, float) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Fill the histogram with specified weight.
fill(float, float, float) - Method in interface hep.aida.tfloat.FloatIHistogram3D
Fill the histogram with weight 1; equivalent to fill(x,y,z,1)..
fill(float, float, float, float) - Method in interface hep.aida.tfloat.FloatIHistogram3D
Fill the histogram with specified weight.
fill(float) - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
fill(float, float) - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
fill(float, float) - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
fill(float, float, float) - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
fill(float, float, float) - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
fill(float, float, float, float) - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
fill(P0D) - Method in class jhplot.H1D
Fill histogram from P0D array
fill(int, AbstractDistribution) - Method in class jhplot.H1D
Fill histogram with random numbers.
fill(P0I) - Method in class jhplot.H1D
Fill histogram from P0I array
fill(double) - Method in class jhplot.H1D
Fill histogram with a value
fill(PND) - Method in class jhplot.H1D
Fill histogram with values from a PND array.
fill(PND, PND) - Method in class jhplot.H1D
Fill histograms with values from PND array.
fill(double[]) - Method in class jhplot.H1D
Fill histogram with array of double values
fill(Cloud1D) - Method in class jhplot.H1D
Fill histogram with array of double values
fill(double[], double[]) - Method in class jhplot.H1D
Fill histogram with array of double values.
fill(int[]) - Method in class jhplot.H1D
Fill histogram with array of integer values
fill(double, double) - Method in class jhplot.H1D
Fill histogram a with weight
fill(double, double) - Method in class jhplot.H2D
Fill H2D histogram assuming all weights are unity.
fill(double, double, double) - Method in class jhplot.H2D
Fill H2D histogram with weights
fill(double[], double[]) - Method in class jhplot.H2D
Fill H2D histogram from 2 arrays.
fill(Cloud2D) - Method in class jhplot.H2D
Fill H2D histogram from Cloud2D.
fill(P0D, P0D) - Method in class jhplot.H2D
Fill H2D histogram from 2 arrays.
fill(P0I, P0I) - Method in class jhplot.H2D
Fill H2D histogram from 2 arrays.
fill(double[], double[], double[]) - Method in class jhplot.H2D
Fill H2D histogram from arrays.
fill(double, double) - Method in class jhplot.HProf1D
Fill profile histogram with X and Y
fill(double, double, double) - Method in class jhplot.HProf1D
Fill profile histogram with X and Y
fill(double[], double[]) - Method in class jhplot.HProf1D
Fill histogram with array of double values.
fill(double[], double[], double[]) - Method in class jhplot.HProf1D
Fill histogram with array of double values.
fill(double, double, double) - Method in class jhplot.HProf2D
Fill histogram assuming all weights are unity.
fill(double, double, double, double) - Method in class jhplot.HProf2D
Fill histogram assuming all weights are unity.
fill(double[], double[], double[]) - Method in class jhplot.HProf2D
Fill histogram from 2 arrays.
fill(double[], double[], double[], double[]) - Method in class jhplot.HProf2D
Fill histogram from 2 arrays.
fill(int, int, double) - Static method in class jhplot.math.DoubleArray
Fills an m x n matrix of doubles with constant c.
fill(int, double) - Static method in class jhplot.math.DoubleArray
Provides an m element array filled with constant c.
fill(int, double, double) - Method in class jhplot.P0D
Fill with a sequence of numbers between min and max.
fill(double[]) - Method in class jhplot.P0D
Fill a P0D container from an array.
fill(int[]) - Method in class jhplot.P0D
Fill a P0D container from an array.
fill(int, Integer, Integer) - Method in class jhplot.P0I
Fill with a sequence of numbers between min and max.
fill(Integer[]) - Method in class jhplot.P0I
Fill a P0I container from an array.
fill(int[]) - Method in class jhplot.P0I
Fill a P0I container from an array.
fill(double[], double[]) - Method in class jhplot.P1D
Fill a P1D container from 2 arrays.
fill(P0D, P0D) - Method in class jhplot.P1D
Fill a P1D container from 2 P0D arrays.
fill(Cloud2D) - Method in class jhplot.P1D
Fill a P1D container from a Cloud2D.
fill(double[], double[], double[]) - Method in class jhplot.P1D
Fill a P1D container from 3 arrays (one represents symmetrical errors on Y).
fill(P0D, P0D, P0D) - Method in class jhplot.P1D
Fill a P1D container from P0D arrays (one represents symmetrical errors on Y).
fill(double[], double[], double[], double[]) - Method in class jhplot.P1D
Fill a P1D container from 4 arrays (last represents asymmetrical upper and lower errors on Y).
fill(double[], double[], double[], double[], double[], double[], double[], double[], double[], double[]) - Method in class jhplot.P1D
Fill the values of a X-Y plot-points with full errors.
fill(double[], double[], double[]) - Method in class jhplot.P2D
Fill a P2D container from 3 arrays.
fill(double[]) - Method in class org.apache.commons.math.random.ValueServer
Fills the input array with values generated using getNext() repeatedly.
fill(int) - Method in class org.apache.commons.math.random.ValueServer
Returns an array of length length with values generated using getNext() repeatedly.
fill_2D(double[], int, int, int, int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram1D
Fill histogram with specified data and weight 1.
fill_2D(double[], double[], int, int, int, int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram1D
Fill histogram with specified data and weights.
fill_2D(double[], int, int, int, int, int) - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
fill_2D(double[], double[], int, int, int, int, int) - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
fill_2D(float[], int, int, int, int, int) - Method in interface hep.aida.tfloat.FloatIHistogram1D
Fill histogram with specified data and weight 1.
fill_2D(float[], float[], int, int, int, int, int) - Method in interface hep.aida.tfloat.FloatIHistogram1D
Fill histogram with specified data and weights.
fill_2D(float[], int, int, int, int, int) - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
fill_2D(float[], float[], int, int, int, int, int) - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BooleanTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ByteTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.CharTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.DoubleTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.FloatTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.IntTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ITupleTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.LongTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ObjectTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ShortTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.StringTupleColumn
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnBoolean
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnByte
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnChar
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnDouble
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFloat
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnInt
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnLong
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnObject
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnShort
 
fillableObject() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnString
 
fillFromToWith(int, int, boolean) - Method in class cern.colt.list.AbstractBooleanList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, byte) - Method in class cern.colt.list.AbstractByteList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, char) - Method in class cern.colt.list.AbstractCharList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, double) - Method in class cern.colt.list.AbstractDoubleList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, float) - Method in class cern.colt.list.AbstractFloatList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, int) - Method in class cern.colt.list.AbstractIntList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, long) - Method in class cern.colt.list.AbstractLongList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, short) - Method in class cern.colt.list.AbstractShortList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, Object) - Method in class cern.colt.list.ObjectArrayList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, boolean) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, byte) - Method in class cern.colt.list.tbyte.AbstractByteList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, char) - Method in class cern.colt.list.tchar.AbstractCharList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, double) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, float) - Method in class cern.colt.list.tfloat.AbstractFloatList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, int) - Method in class cern.colt.list.tint.AbstractIntList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, long) - Method in class cern.colt.list.tlong.AbstractLongList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, Object) - Method in class cern.colt.list.tobject.ObjectArrayList
Sets the specified range of elements in the specified array to the specified value.
fillFromToWith(int, int, short) - Method in class cern.colt.list.tshort.AbstractShortList
Sets the specified range of elements in the specified array to the specified value.
fillHistogram(IHistogram1D) - Method in class hep.aida.ref.histogram.Cloud1D
 
fillHistogram(IHistogram2D) - Method in class hep.aida.ref.histogram.Cloud2D
 
fillHistogram(IHistogram3D) - Method in class hep.aida.ref.histogram.Cloud3D
 
fillInvBinSizeWeight(double) - Method in class jhplot.H1D
Fill histogram with a value, weighting it by inverse of bin size.
fillInvBinSizeWeight(double) - Method in class jhplot.HProf1D
Fill histogram with a value, weighting it by inverse of bin size.
fillP0D(P0D, P0D) - Method in class jhplot.HProf1D
Fill histogram from two P0D arrays
fillPath(ITree, IManagedObject) - Static method in class hep.aida.ref.AidaUtils
 
fillPlot() - Method in class jhplot.SPlot
Rescale so that the data that is currently plotted just fits.
fillRandom(int, AbstractDistribution) - Method in class cern.colt.list.DoubleArrayList
Fill array with random numbers
fillRandom(int, AbstractDistribution) - Method in class cern.colt.list.IntArrayList
Fill array with random numbers
fillRandom(DataPoint, DataPoint, int, int) - Method in class jminhep.cluster.DataHolder
Fill an existing data holder with random numbers
fillWithVectors(String, Vector, Vector) - Method in class jhplot.SPsheet
Fill the table from the Vectors
Filter - Class in hep.aida.ref.tuple
 
Filter(String) - Constructor for class hep.aida.ref.tuple.Filter
Default contructor.
Filter(String, int) - Constructor for class hep.aida.ref.tuple.Filter
 
Filter(String, int, int) - Constructor for class hep.aida.ref.tuple.Filter
 
finalizeStep() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Finalize the step.
find(String) - Method in class hep.aida.ref.tree.Tree
Get the IManagedObject at a given path in the ITree.
find(double) - Method in class jhplot.P0D
Returns the index of first occurrence of the specified element
find(Integer) - Method in class jhplot.P0I
Returns the index of first occurrence of the specified element
findBin(double) - Method in class jhplot.H1D
Convert a coordinate on the axis to a bin number
findBinX(double) - Method in class jhplot.H2D
Convert a coordinate X on the axis to a bin number
findBinY(double) - Method in class jhplot.H2D
Convert a coordinate Y on the axis to a bin number
findClass(String) - Method in class umontreal.iro.lecuyer.util.ClassFinder
Tries to find the class corresponding to the simple name name.
findColumn(String) - Method in class hep.aida.ref.tuple.AbstractTuple
 
findColumn(String) - Method in class hep.aida.ref.tuple.ChainedTuple
Convert a name to a column index.
findColumn(String) - Method in class hep.aida.ref.tuple.Tuple
 
findDescriptor(int) - Method in class jhplot.io.csv.bean.HeaderColumnNameMappingStrategy
 
findDescriptor(int) - Method in interface jhplot.io.csv.bean.MappingStrategy
Implementation will have to return a property descriptor from a bean based on the current column.
findex(int, IndexFunction) - Static method in class jhplot.math.DoubleArray
Provides a sequence of values to which some function has been applied.
findInArray(String, String[]) - Static method in class hep.aida.ref.AidaUtils
 
findKey(String) - Method in class hep.aida.ref.Annotation
 
findObject(String) - Method in class hep.aida.ref.tree.Tree
 
findPath(IManagedObject) - Method in class hep.aida.ref.tree.Tree
Get the full path of an IManagedObject.
findRoot(double, double) - Method in class jhplot.math.num.root.BisectionRootFinder
Find a root of the target function that lies in the interval [ min, max].
findRoot(double, double) - Method in class jhplot.math.num.root.BrentRootFinder
Find a root of the target function that lies between the two initial approximations, x0 and x1.
findRoot(double, double) - Method in class jhplot.math.num.root.FalsePositionRootFinder
Find a root of the target function that lies in the interval [ min, max].
findRoot(double) - Method in class jhplot.math.num.root.NewtonRootFinder
Find a root of the target function that lies close to x.
findRoot(double, double) - Method in class jhplot.math.num.root.SecantRootFinder
Find a root of the target function that lies around the two initial approximations, x0 and x1.
findSlice(double[]) - Method in class jhplot.math.Slicing
 
findTree(String) - Method in class hep.aida.ref.tree.Tree
 
findTuple(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
findTuple(int) - Method in class hep.aida.ref.tuple.ChainedTuple
 
findTuple(int) - Method in class hep.aida.ref.tuple.Tuple
Get Folder at the current cursor position.
fine_structure_const - Static variable in class cern.clhep.PhysicalConstants
 
FINITE - Static variable in class org.apache.commons.math.dfp.Dfp
Indicator value for normal finite numbers.
finiteCenteredDifferenceDerivative(MathFunction, double, double) - Static method in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Returns (f (x + h) - f (x - h))/(2h), an estimate of the first derivative of f (x) using centered differences.
finiteCenteredDifferenceDerivative(MathFunction, double, int, double) - Static method in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Computes and returns an estimate of the nth derivative of the function f (x) using finite centered differences.
finiteDifferenceDerivative(MathFunction, double, int, double) - Static method in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Computes and returns an estimate of the nth derivative of the function f (x).
fireConnectionEvent(String, boolean) - Method in class hep.aida.ref.tree.Tree
 
FirstMoment - Class in org.apache.commons.math.stat.descriptive.moment
Computes the first moment (arithmetic mean).
FirstMoment() - Constructor for class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Create a FirstMoment instance
FirstMoment(FirstMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Copy constructor, creates a new FirstMoment identical to the original
FirstOrderConverter - Class in org.apache.commons.math.ode
This class converts second order differential equations to first order ones.
FirstOrderConverter(SecondOrderDifferentialEquations) - Constructor for class org.apache.commons.math.ode.FirstOrderConverter
Simple constructor.
FirstOrderDifferentialEquations - Interface in org.apache.commons.math.ode
This interface represents a first order differential equations set.
FirstOrderIntegrator - Interface in org.apache.commons.math.ode
This interface represents a first order integrator for differential equations.
FirstOrderIntegratorWithJacobians - Class in org.apache.commons.math.ode.jacobians
Deprecated. as of 2.2 the complete package is deprecated, it will be replaced in 3.0 by a completely rewritten implementation
FirstOrderIntegratorWithJacobians(FirstOrderIntegrator, ParameterizedODE, double[], double[], double[]) - Constructor for class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Build an enhanced integrator using internal differentiation to compute jacobians.
FirstOrderIntegratorWithJacobians(FirstOrderIntegrator, ODEWithJacobians) - Constructor for class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Build an enhanced integrator using ODE builtin jacobian computation features.
FisherFDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Fisher F distribution with n and m degrees of freedom, where n and m are positive integers.
FisherFDist(int, int) - Constructor for class umontreal.iro.lecuyer.probdist.FisherFDist
Constructs a Fisher F distribution with n and m degrees of freedom.
FisherFGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the Fisher F distribution with n and m degrees of freedom, where n and m are positive integers.
FisherFGen(RandomStream, int, int) - Constructor for class umontreal.iro.lecuyer.randvar.FisherFGen
Creates a Fisher F random variate generator with n and m degrees of freedom, using stream s.
FisherFGen(RandomStream, FisherFDist) - Constructor for class umontreal.iro.lecuyer.randvar.FisherFGen
Creates a new generator for the distribution dist, using stream s.
fit(Function) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IFitData, IFunction) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IFitData, IFunction, String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IFitData, IFunction, String, Object) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IBaseHistogram, IFunction) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IBaseHistogram, IFunction, String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IBaseHistogram, String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IBaseHistogram, String, String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IBaseHistogram, String, double[]) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IBaseHistogram, String, double[], String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, IFunction) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, IFunction, String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, IFunction, double[]) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, IFunction, String, Object) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, IFunction, double[], String, Object) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, String, String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, String, String, Object) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, String, double[]) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, String, double[], String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IDataPointSet, String, double[], String, Object) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IFitData, String, double[]) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IFitData, String, double[], String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IFitData, String, double[], String, Object) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IFitData, String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IFitData, String, String) - Method in class hep.aida.ref.fitter.Fitter
 
fit(IFitData, String, String, Object) - Method in class hep.aida.ref.fitter.Fitter
 
fit(H1D) - Method in class jhplot.HFitter
Fit histogram
fit(P1D) - Method in class jhplot.HFitter
Fit P1D
fit(PND) - Method in class jhplot.HFitter
Fit PND (all errors set to be zero).
fit(H2D) - Method in class jhplot.HFitter
Fit H2D histogram
fit(H1D, String, String) - Method in class jhplot.HPlot
Fit 1D histogram with the function F1D
fit(H1D, String, String) - Method in class jhplot.HPlotJa
Fit 1D histogram with the function F1D
fit(ParametricRealFunction, double[]) - Method in class org.apache.commons.math.optimization.fitting.CurveFitter
Fit a curve.
fit() - Method in class org.apache.commons.math.optimization.fitting.GaussianFitter
Fits Gaussian function to the observed points.
fit() - Method in class org.apache.commons.math.optimization.fitting.HarmonicFitter
Fit an harmonic function to the observed points.
fit() - Method in class org.apache.commons.math.optimization.fitting.PolynomialFitter
Get the polynomial fitting the weighted (x, y) points.
FitData - Class in hep.aida.ref.fitter.fitdata
 
FitData() - Constructor for class hep.aida.ref.fitter.fitdata.FitData
Creates a new instance of FitData
FitDataCreator - Class in hep.aida.ref.fitter.fitdata
Creates FitData.
FitDataCreator() - Constructor for class hep.aida.ref.fitter.fitdata.FitDataCreator
 
FitDataIterator - Class in hep.aida.ref.fitter.fitdata
 
FitDataIterator(ITuple) - Constructor for class hep.aida.ref.fitter.fitdata.FitDataIterator
 
fitF() - Method in class jhplot.HPlot
Return FitFactory associated with the plot
fitF() - Method in class jhplot.HPlotJa
Return FitFactory associated with the plot
FitFactory - Class in hep.aida.ref.fitter
 
FitFactory() - Constructor for class hep.aida.ref.fitter.FitFactory
 
fitMethodName() - Method in class hep.aida.ref.fitter.FitResult
 
fitMethodName() - Method in class hep.aida.ref.fitter.Fitter
 
fitMethodNames() - Method in class hep.aida.ref.fitter.fitmethod.AbstractFitMethod
 
Fitness - Interface in org.apache.commons.math.genetics
Fitness of a chromosome.
fitness() - Method in interface org.apache.commons.math.genetics.Fitness
Compute the fitness.
fitOneOrSeveralDistributions(double[]) - Static method in class flanagan.analysis.Regression
 
fitOneOrSeveralDistributions() - Method in class flanagan.analysis.Stat
 
fitOneOrSeveralDistributions(double[]) - Static method in class flanagan.analysis.Stat
 
FitParameterSettings - Class in hep.aida.ref.fitter
 
FitParameterSettings(String) - Constructor for class hep.aida.ref.fitter.FitParameterSettings
Creates a new instance of FitParameterSettings.
fitParameterSettings(String) - Method in class hep.aida.ref.fitter.FitResult
 
fitParameterSettings(String) - Method in class hep.aida.ref.fitter.Fitter
 
FitResult - Class in hep.aida.ref.fitter
 
FitResult(int) - Constructor for class hep.aida.ref.fitter.FitResult
 
FitResult(int, double) - Constructor for class hep.aida.ref.fitter.FitResult
 
fitStatus() - Method in class hep.aida.ref.fitter.FitResult
 
fittedFunction() - Method in class hep.aida.ref.fitter.FitResult
 
fittedParameter(String) - Method in class hep.aida.ref.fitter.FitResult
 
fittedParameterNames() - Method in class hep.aida.ref.fitter.FitResult
 
fittedParameters() - Method in class hep.aida.ref.fitter.FitResult
 
Fitter - Class in hep.aida.ref.fitter
 
Fitter(String, String, String) - Constructor for class hep.aida.ref.fitter.Fitter
Create a new Fitter specifying the underlying optimizing engine.
fitType() - Method in class hep.aida.ref.fitter.fitdata.FitData
 
fitType() - Method in class hep.aida.ref.fitter.fitmethod.AbstractFitMethod
 
fix1stArgument(double) - Method in class org.apache.commons.math.analysis.BinaryFunction
Deprecated. Get a composable function by fixing the first argument of the instance.
fix2ndArgument(double) - Method in class org.apache.commons.math.analysis.BinaryFunction
Deprecated. Get a composable function by fixing the second argument of the instance.
FixedAxis - Class in cern.hep.aida.ref
Fixed-width axis; A reference implementation of hep.aida.IAxis.
FixedAxis(int, double, double) - Constructor for class cern.hep.aida.ref.FixedAxis
Create an Axis
FixedAxis - Class in hep.aida.ref.histogram
Fixed-width axis; A reference implementation of hep.aida.IAxis.
FixedAxis(int, double, double) - Constructor for class hep.aida.ref.histogram.FixedAxis
Create an Axis
FixedGenerationCount - Class in org.apache.commons.math.genetics
Stops after a fixed number of generations.
FixedGenerationCount(int) - Constructor for class org.apache.commons.math.genetics.FixedGenerationCount
Create a new FixedGenerationCount instance.
FixedStepHandler - Interface in org.apache.commons.math.ode.sampling
This interface represents a handler that should be called after each successful fixed step.
FLAG_DIV_ZERO - Static variable in class org.apache.commons.math.dfp.DfpField
IEEE 854-1987 flag for division by zero.
FLAG_INEXACT - Static variable in class org.apache.commons.math.dfp.DfpField
IEEE 854-1987 flag for inexact result.
FLAG_INVALID - Static variable in class org.apache.commons.math.dfp.DfpField
IEEE 854-1987 flag for invalid operation.
FLAG_OVERFLOW - Static variable in class org.apache.commons.math.dfp.DfpField
IEEE 854-1987 flag for overflow.
FLAG_UNDERFLOW - Static variable in class org.apache.commons.math.dfp.DfpField
IEEE 854-1987 flag for underflow.
flanagan.analysis - package flanagan.analysis
 
flanagan.integration - package flanagan.integration
 
flanagan.interpolation - package flanagan.interpolation
 
flanagan.math - package flanagan.math
 
flatten(Object[]) - Static method in class org.apache.commons.math.exception.util.ArgUtils
Transform a multidimensional array into a one-dimensional list.
FLine(float, float) - Static method in class jhplot.jadraw.Diagram
Get a fermion line
Float27Function - Interface in cern.colt.function.tfloat
Interface that represents a function object: a function that takes 27 arguments and returns a single value.
Float9Function - Interface in cern.colt.function.tfloat
Interface that represents a function object: a function that takes 9 arguments and returns a single value.
FloatAMG - Class in cern.colt.matrix.tfloat.algo.solver.preconditioner
Algebraic multigrid preconditioner.
FloatAMG(float, float, float, float, int, int, int, int, float) - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatAMG
Sets up the algebraic multigrid preconditioner
FloatAMG(float, float, int, int, int, int, float) - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatAMG
Sets up the algebraic multigrid preconditioner.
FloatAMG() - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatAMG
Sets up the algebraic multigrid preconditioner using some default parameters.
FloatArithmetic - Class in cern.jet.math.tfloat
Arithmetic functions.
FloatArrayList - Class in cern.colt.list
Resizable list holding float elements; implemented with arrays.
FloatArrayList() - Constructor for class cern.colt.list.FloatArrayList
Constructs an empty list.
FloatArrayList(float[]) - Constructor for class cern.colt.list.FloatArrayList
Constructs a list containing the specified elements.
FloatArrayList(int) - Constructor for class cern.colt.list.FloatArrayList
Constructs an empty list with the specified initial capacity.
FloatArrayList - Class in cern.colt.list.tfloat
Resizable list holding float elements; implemented with arrays.
FloatArrayList() - Constructor for class cern.colt.list.tfloat.FloatArrayList
Constructs an empty list.
FloatArrayList(float[]) - Constructor for class cern.colt.list.tfloat.FloatArrayList
Constructs a list containing the specified elements.
FloatArrayList(int) - Constructor for class cern.colt.list.tfloat.FloatArrayList
Constructs an empty list with the specified initial capacity.
FloatBiCG - Class in cern.colt.matrix.tfloat.algo.solver
BiCG solver.
FloatBiCG(FloatMatrix1D) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatBiCG
Constructor for BiCG.
FloatBiCGstab - Class in cern.colt.matrix.tfloat.algo.solver
BiCG stablized solver.
FloatBiCGstab(FloatMatrix1D) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatBiCGstab
Constructor for BiCGstab.
FloatBinBinFunction1D - Interface in hep.aida.tfloat.bin
Interface that represents a function object: a function that takes two bins as arguments and returns a single value.
FloatBinFunction1D - Interface in hep.aida.tfloat.bin
Interface that represents a function object: a function that takes two bins as arguments and returns a single value.
FloatBinFunctions1D - Class in hep.aida.tfloat.bin
Function objects computing dynamic bin aggregations; to be passed to generic methods.
FloatBlas - Interface in cern.colt.matrix.tfloat.algo
Subset of the BLAS (Basic Linear Algebra System); High quality "building block" routines for performing basic vector and matrix operations.
FloatBuffer - Class in cern.colt.buffer.tfloat
Fixed sized (non resizable) streaming buffer connected to a target FloatBufferConsumer to which data is automatically flushed upon buffer overflow.
FloatBuffer(FloatBufferConsumer, int) - Constructor for class cern.colt.buffer.tfloat.FloatBuffer
Constructs and returns a new buffer with the given target.
FloatBuffer2D - Class in cern.colt.buffer.tfloat
Fixed sized (non resizable) streaming buffer connected to a target FloatBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
FloatBuffer2D(FloatBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.tfloat.FloatBuffer2D
Constructs and returns a new buffer with the given target.
FloatBuffer2DConsumer - Interface in cern.colt.buffer.tfloat
Target of a streaming FloatBuffer2D into which data is flushed upon buffer overflow.
FloatBuffer3D - Class in cern.colt.buffer.tfloat
Fixed sized (non resizable) streaming buffer connected to a target FloatBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
FloatBuffer3D(FloatBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.tfloat.FloatBuffer3D
Constructs and returns a new buffer with the given target.
FloatBuffer3DConsumer - Interface in cern.colt.buffer.tfloat
Target of a streaming FloatBuffer3D into which data is flushed upon buffer overflow.
FloatBufferConsumer - Interface in cern.colt.buffer.tfloat
Target of a streaming FloatBuffer into which data is flushed upon buffer overflow.
FloatCG - Class in cern.colt.matrix.tfloat.algo.solver
Conjugate Gradients solver.
FloatCG(FloatMatrix1D) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatCG
Constructor for CG.
FloatCGLS - Class in cern.colt.matrix.tfloat.algo.solver
CGLS is Conjugate Gradient for Least Squares method used for solving large-scale, ill-posed inverse problems of the form: b = A*x + noise.
FloatCGLS() - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatCGLS
 
FloatCGS - Class in cern.colt.matrix.tfloat.algo.solver
Conjugate Gradients squared solver.
FloatCGS(FloatMatrix1D) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatCGS
Constructor for CGS.
FloatChebyshev - Class in cern.colt.matrix.tfloat.algo.solver
Chebyshev solver.
FloatChebyshev(FloatMatrix1D, float, float) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatChebyshev
Constructor for Chebyshev.
FloatComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
FloatComparator - Interface in cern.colt.function.tfloat
A comparison function which imposes a total ordering on some collection of elements.
FloatConstants - Class in cern.jet.math.tfloat
Defines some useful constants.
FloatConverter - Class in hep.aida.tfloat.ref
Histogram conversions, for example to String and XML format; This class requires the Colt distribution, whereas the rest of the package is entirelly stand-alone.
FloatConverter() - Constructor for class hep.aida.tfloat.ref.FloatConverter
Creates a new histogram converter.
FloatDescriptive - Class in cern.jet.stat.tfloat
Basic descriptive statistics.
FloatDiagonal - Class in cern.colt.matrix.tfloat.algo.solver.preconditioner
Diagonal preconditioner.
FloatDiagonal(int) - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatDiagonal
Constructor for DiagonalPreconditioner
FloatEquiDepthHistogram - Class in cern.jet.stat.tfloat.quantile
Read-only equi-depth histogram for selectivity estimation.
FloatEquiDepthHistogram(float[]) - Constructor for class cern.jet.stat.tfloat.quantile.FloatEquiDepthHistogram
Constructs an equi-depth histogram with the given quantile elements.
FloatFactory1D - Class in cern.colt.matrix.tfloat
Factory for convenient construction of 1-d matrices holding float cells.
FloatFactory2D - Class in cern.colt.matrix.tfloat
Factory for convenient construction of 2-d matrices holding float cells.
FloatFactory3D - Class in cern.colt.matrix.tfloat
Factory for convenient construction of 3-d matrices holding float cells.
FloatFixedAxis - Class in hep.aida.tfloat.ref
Fixed-width axis; A reference implementation of hep.aida.IAxis.
FloatFixedAxis(int, float, float) - Constructor for class hep.aida.tfloat.ref.FloatFixedAxis
Create an Axis
FloatFloatFunction - Interface in cern.colt.function.tfloat
Interface that represents a function object: a function that takes two arguments and returns a single value.
FloatFloatProcedure - Interface in cern.colt.function.tfloat
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
FloatFormatter - Class in cern.colt.matrix.tfloat.algo
Flexible, well human readable matrix print formatting; By default decimal point aligned.
FloatFormatter() - Constructor for class cern.colt.matrix.tfloat.algo.FloatFormatter
Constructs and returns a matrix formatter with format "%G".
FloatFormatter(String) - Constructor for class cern.colt.matrix.tfloat.algo.FloatFormatter
Constructs and returns a matrix formatter.
FloatFunction - Interface in cern.colt.function.tfloat
Interface that represents a function object: a function that takes a single argument and returns a single value.
FloatFunctions - Class in cern.jet.math.tfloat
Function objects to be passed to generic methods.
FloatGivensRotation - Class in cern.colt.matrix.tfloat.algo.solver
Givens plane rotation
FloatGivensRotation(float, float) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatGivensRotation
Constructs a Givens plane rotation for a given 2-vector
FloatGMRES - Class in cern.colt.matrix.tfloat.algo.solver
GMRES solver.
FloatGMRES(FloatMatrix1D) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatGMRES
Constructor for GMRES.
FloatGMRES(FloatMatrix1D, int) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatGMRES
Constructor for GMRES.
FloatHistogram1D - Class in hep.aida.tfloat.ref
A reference implementation of hep.aida.IHistogram1D.
FloatHistogram1D(String, float[]) - Constructor for class hep.aida.tfloat.ref.FloatHistogram1D
Creates a variable-width histogram.
FloatHistogram1D(String, FloatIAxis) - Constructor for class hep.aida.tfloat.ref.FloatHistogram1D
Creates a histogram with the given axis binning.
FloatHistogram1D(String, int, float, float) - Constructor for class hep.aida.tfloat.ref.FloatHistogram1D
Creates a fixed-width histogram.
FloatHistogram1DContents - Class in hep.aida.tfloat.ref
 
FloatHistogram1DContents(int[], float[], float[], int, float, float, float, float) - Constructor for class hep.aida.tfloat.ref.FloatHistogram1DContents
 
FloatHistogram2D - Class in hep.aida.tfloat.ref
A reference implementation of hep.aida.IHistogram2D.
FloatHistogram2D(String, float[], float[]) - Constructor for class hep.aida.tfloat.ref.FloatHistogram2D
Creates a variable-width histogram.
FloatHistogram2D(String, int, float, float, int, float, float) - Constructor for class hep.aida.tfloat.ref.FloatHistogram2D
Creates a fixed-width histogram.
FloatHistogram2D(String, FloatIAxis, FloatIAxis) - Constructor for class hep.aida.tfloat.ref.FloatHistogram2D
Creates a histogram with the given axis binning.
FloatHistogram3D - Class in hep.aida.tfloat.ref
A reference implementation of hep.aida.IHistogram3D.
FloatHistogram3D(String, float[], float[], float[]) - Constructor for class hep.aida.tfloat.ref.FloatHistogram3D
Creates a variable-width histogram.
FloatHistogram3D(String, int, float, float, int, float, float, int, float, float) - Constructor for class hep.aida.tfloat.ref.FloatHistogram3D
Creates a fixed-width histogram.
FloatHistogram3D(String, FloatIAxis, FloatIAxis, FloatIAxis) - Constructor for class hep.aida.tfloat.ref.FloatHistogram3D
Creates a histogram with the given axis binning.
FloatHyBR - Class in cern.colt.matrix.tfloat.algo.solver
HyBR is a Hybrid Bidiagonalization Regularization method used for solving large-scale, ill-posed inverse problems of the form: b = A*x + noise The method combines an iterative Lanczos Bidiagonalization (LBD) Method with an SVD-based regularization method to stabilize the semiconvergence behavior that is characteristic of many ill-posed problems.
FloatHyBR() - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatHyBR
Creates new instance of HyBR solver with default parameters:

innerSolver = HyBR.InnerSolver.TIKHONOV
regularizationMethod = HyBR.RegularizationMethod.ADAPTWGCV
regularizationParameter = 0
omega = 0
reorthogonalize = false
beginRegularization = 2
flatTolerance = 1e-6
computeRnrm = false;
FloatHyBR(HyBRInnerSolver, HyBRRegularizationMethod, float, float, boolean, int, float, boolean) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatHyBR
Creates new instance of HyBR solver.
FloatIAxis - Interface in hep.aida.tfloat
An IAxis represents a binned histogram axis.
FloatICC - Class in cern.colt.matrix.tfloat.algo.solver.preconditioner
Incomplete Cholesky preconditioner without fill-in using a compressed row matrix as internal storage
FloatICC(int) - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatICC
Sets up the ICC preconditioner
FloatIdentity - Class in cern.colt.matrix.tfloat.algo.solver.preconditioner
 
FloatIdentity() - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatIdentity
 
FloatIHistogram - Interface in hep.aida.tfloat
A common base interface for IHistogram1D, IHistogram2D and IHistogram3D.
FloatIHistogram1D - Interface in hep.aida.tfloat
A Java interface corresponding to the AIDA 1D Histogram.
FloatIHistogram2D - Interface in hep.aida.tfloat
A Java interface corresponding to the AIDA 2D Histogram.
FloatIHistogram3D - Interface in hep.aida.tfloat
A Java interface corresponding to the AIDA 3D Histogram.
FloatILU - Class in cern.colt.matrix.tfloat.algo.solver.preconditioner
ILU(0) preconditioner using a compressed row matrix as internal storage
FloatILU(int) - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatILU
Sets up the ILU preconditioner
FloatILUT - Class in cern.colt.matrix.tfloat.algo.solver.preconditioner
ILU preconditioner with fill-in.
FloatILUT(int, float, int) - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatILUT
Sets up the preconditioner for the problem size
FloatILUT(int) - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatILUT
Sets up the preconditioner for the given problem size.
FloatIntProcedure - Interface in cern.colt.function.tfloat
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
FloatIR - Class in cern.colt.matrix.tfloat.algo.solver
Iterative Refinement.
FloatIR(FloatMatrix1D) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatIR
Constructor for IR.
FloatIterationMonitor - Interface in cern.colt.matrix.tfloat.algo.solver
Monitors the iterative solution process for convergence and divergence.
FloatIterationReporter - Interface in cern.colt.matrix.tfloat.algo.solver
Reports on the progress of an iterative solver
FloatIterativeSolver - Interface in cern.colt.matrix.tfloat.algo.solver
Iterative linear solver.
FloatListAdapter - Class in cern.colt.list.adapter
Adapter that permits an AbstractFloatList to be viewed and treated as a JDK 1.2 AbstractList.
FloatListAdapter(AbstractFloatList) - Constructor for class cern.colt.list.adapter.FloatListAdapter
Constructs a list backed by the specified content list.
FloatListAdapter - Class in cern.colt.list.tfloat
Adapter that permits an AbstractFloatList to be viewed and treated as a JDK 1.2 AbstractList.
FloatListAdapter(AbstractFloatList) - Constructor for class cern.colt.list.tfloat.FloatListAdapter
Constructs a list backed by the specified content list.
FloatLongProcedure - Interface in cern.colt.function.tfloat
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
FloatMatrix1D - Class in cern.colt.matrix.tfloat
Abstract base class for 1-d matrices (aka vectors) holding float elements.
FloatMatrix1DComparator - Interface in cern.colt.matrix.tfloat.algo
A comparison function which imposes a total ordering on some collection of elements.
FloatMatrix1DProcedure - Interface in cern.colt.matrix.tfloat
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
FloatMatrix2D - Class in cern.colt.matrix.tfloat
Abstract base class for 2-d matrices holding float elements.
FloatMatrix2DComparator - Interface in cern.colt.matrix.tfloat.algo
A comparison function which imposes a total ordering on some collection of elements.
FloatMatrix2DMatrix2DFunction - Interface in cern.colt.matrix.tfloat.algo
Interface that represents a function object: a function that takes two arguments and returns a single value.
FloatMatrix2DProcedure - Interface in cern.colt.matrix.tfloat
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
FloatMatrix3D - Class in cern.colt.matrix.tfloat
Abstract base class for 3-d matrices holding float elements.
FloatMatrix3DProcedure - Interface in cern.colt.matrix.tfloat
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
FloatMersenneTwister - Class in cern.jet.random.tfloat.engine
MersenneTwister (MT19937) is one of the strongest uniform pseudo-random number generators known so far; at the same time it is quick.
FloatMersenneTwister() - Constructor for class cern.jet.random.tfloat.engine.FloatMersenneTwister
Constructs and returns a random number generator with a default seed, which is a constant.
FloatMersenneTwister(int) - Constructor for class cern.jet.random.tfloat.engine.FloatMersenneTwister
Constructs and returns a random number generator with the given seed.
FloatMersenneTwister(Date) - Constructor for class cern.jet.random.tfloat.engine.FloatMersenneTwister
Constructs and returns a random number generator seeded with the given date.
FloatMRNSD - Class in cern.colt.matrix.tfloat.algo.solver
MRNSD is Modified Residual Norm Steepest Descent method used for solving large-scale, ill-posed inverse problems of the form: b = A*x + noise.
FloatMRNSD() - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatMRNSD
 
FloatMult - Class in cern.jet.math.tfloat
Only for performance tuning of compute intensive linear algebraic computations.
FloatNotConvergedException - Exception in cern.colt.matrix.tfloat.algo.solver
Signals lack of convergence of an iterative process
FloatNotConvergedException(FloatNotConvergedException.Reason, String) - Constructor for exception cern.colt.matrix.tfloat.algo.solver.FloatNotConvergedException
Constructor for NotConvergedException
FloatNotConvergedException(FloatNotConvergedException.Reason) - Constructor for exception cern.colt.matrix.tfloat.algo.solver.FloatNotConvergedException
Constructor for NotConvergedException.
FloatNotConvergedException.Reason - Enum in cern.colt.matrix.tfloat.algo.solver
Possible reasons for lack of convergence
FloatPartitioning - Class in cern.colt.matrix.tfloat.algo
Given some interval boundaries, partitions matrices such that cell values falling into an interval are placed next to each other.
FloatPlusMultFirst - Class in cern.jet.math.tfloat
Only for performance tuning of compute intensive linear algebraic computations.
FloatPlusMultSecond - Class in cern.jet.math.tfloat
Only for performance tuning of compute intensive linear algebraic computations.
FloatPreconditioner - Interface in cern.colt.matrix.tfloat.algo.solver.preconditioner
Preconditioner interface.
FloatProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
FloatProcedure - Interface in cern.colt.function.tfloat
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
FloatProperty - Class in cern.colt.matrix.tfloat.algo
Tests matrices for linear algebraic properties (equality, tridiagonality, symmetry, singularity, etc).
FloatProperty(float) - Constructor for class cern.colt.matrix.tfloat.algo.FloatProperty
Constructs an instance with a tolerance of Math.abs(newTolerance).
FloatQMR - Class in cern.colt.matrix.tfloat.algo.solver
Quasi-Minimal Residual method.
FloatQMR(FloatMatrix1D) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatQMR
Constructor for QMR.
FloatQMR(FloatMatrix1D, FloatPreconditioner, FloatPreconditioner) - Constructor for class cern.colt.matrix.tfloat.algo.solver.FloatQMR
Constructor for QMR.
FloatQuantileFinder - Interface in cern.jet.stat.tfloat.quantile
The interface shared by all quantile finders, no matter if they are exact or approximate.
FloatQuantileFinderFactory - Class in cern.jet.stat.tfloat.quantile
Factory constructing exact and approximate quantile finders for both known and unknown N.
FloatRandomEngine - Class in cern.jet.random.tfloat.engine
Abstract base class for uniform pseudo-random number generating engines.
FloatRandomSampler - Class in cern.jet.random.tfloat.sampling
Space and time efficiently computes a sorted Simple Random Sample Without Replacement (SRSWOR), that is, a sorted set of n random numbers from an interval of N numbers; Example: Computing n=3 random numbers from the interval [1,50] may yield the sorted random set (7,13,47).
FloatRandomSampler(long, long, long, FloatRandomEngine) - Constructor for class cern.jet.random.tfloat.sampling.FloatRandomSampler
Constructs a random sampler that computes and delivers sorted random sets in blocks.
FloatRandomSamplingAssistant - Class in cern.jet.random.tfloat.sampling
Conveniently computes a stable Simple Random Sample Without Replacement (SRSWOR) subsequence of n elements from a given input sequence of N elements; Example: Computing a sublist of n=3 random elements from a list (1,...,50) may yield the sublist (7,13,47).
FloatRandomSamplingAssistant(long, long, FloatRandomEngine) - Constructor for class cern.jet.random.tfloat.sampling.FloatRandomSamplingAssistant
Constructs a random sampler that samples n random elements from an input sequence of N elements.
FloatSorting - Class in cern.colt.matrix.tfloat.algo
Matrix quicksorts and mergesorts.
FloatSSOR - Class in cern.colt.matrix.tfloat.algo.solver.preconditioner
SSOR preconditioner.
FloatSSOR(int, boolean, float, float) - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatSSOR
Constructor for SSOR
FloatSSOR(int) - Constructor for class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatSSOR
Constructor for SSOR.
FloatStatistic - Class in cern.colt.matrix.tfloat.algo
Basic statistics operations on matrices.
FloatStatistic.VectorVectorFunction - Interface in cern.colt.matrix.tfloat.algo
Interface that represents a function object: a function that takes two argument vectors and returns a single value.
FloatStencil - Class in cern.colt.matrix.tfloat.algo
Stencil operations.
floatTOdouble(float[]) - Static method in class flanagan.math.Fmath
 
FloatUniform - Class in cern.jet.random.tfloat
Uniform distribution; Math definition and animated definition.
FloatUniform(float, float, int) - Constructor for class cern.jet.random.tfloat.FloatUniform
Constructs a uniform distribution with the given minimum and maximum, using a FloatMersenneTwister seeded with the given seed.
FloatUniform(float, float, FloatRandomEngine) - Constructor for class cern.jet.random.tfloat.FloatUniform
Constructs a uniform distribution with the given minimum and maximum.
FloatUniform(FloatRandomEngine) - Constructor for class cern.jet.random.tfloat.FloatUniform
Constructs a uniform distribution with min=0.0 and max=1.0.
floatValue() - Method in class org.apache.commons.math.fraction.BigFraction
Gets the fraction as a float.
floatValue() - Method in class org.apache.commons.math.fraction.Fraction
Gets the fraction as a float.
FloatVariableAxis - Class in hep.aida.tfloat.ref
Variable-width axis; A reference implementation of hep.aida.IAxis.
FloatVariableAxis(float[]) - Constructor for class hep.aida.tfloat.ref.FloatVariableAxis
Constructs and returns an axis with the given bin edges.
FLoop(float, float) - Static method in class jhplot.jadraw.Diagram
Get a fermion loop object
floor(double) - Static method in class cern.jet.math.Arithmetic
Returns the largest long <= value.
floor - Static variable in class cern.jet.math.Functions
Function that returns Math.floor(a).
floor(double) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Returns the largest long <= value.
floor - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.floor(a).
floor(float) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Returns the largest long <= value.
floor - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.floor(a).
floor() - Method in class flanagan.analysis.Stat
 
floor() - Method in class flanagan.math.ArrayMaths
 
floor(double[][]) - Static method in class jhplot.math.IntegerArray
 
floor(double[]) - Static method in class jhplot.math.IntegerArray
 
FLOOR - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.floor method wrapped as a ComposableFunction.
floor() - Method in class org.apache.commons.math.dfp.Dfp
Round to an integer using the round floor mode.
floor(double) - Static method in class org.apache.commons.math.util.FastMath
Get the largest whole number smaller than x.
fluidOunceUKtoUS(double) - Static method in class flanagan.math.Conv
 
fluidOunceUKtoUS(double) - Static method in class flanagan.math.Fmath
 
fluidOunceUStoUK(double) - Static method in class flanagan.math.Conv
 
fluidOunceUStoUK(double) - Static method in class flanagan.math.Fmath
 
flush() - Method in class cern.colt.buffer.DoubleBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.DoubleBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.DoubleBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.IntBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.IntBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.IntBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.ObjectBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tboolean.BooleanBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tboolean.BooleanBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tboolean.BooleanBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tbyte.ByteBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tbyte.ByteBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tbyte.ByteBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tchar.CharBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tchar.CharBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tchar.CharBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tdouble.DoubleBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tdouble.DoubleBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tdouble.DoubleBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tfloat.FloatBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tfloat.FloatBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tfloat.FloatBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tint.IntBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tint.IntBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tint.IntBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tlong.LongBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tlong.LongBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tlong.LongBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tobject.ObjectBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tshort.ShortBuffer
Adds all internally buffered elements to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tshort.ShortBuffer2D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class cern.colt.buffer.tshort.ShortBuffer3D
Adds all internally buffered points to the receiver's target, then resets the current buffer size to zero.
flush() - Method in class jhplot.io.csv.CSVWriter
Flush underlying stream to writer.
flush() - Method in class jhplot.math.io.LEDataOutputStream
 
Fmath - Class in flanagan.math
 
Fmath() - Constructor for class flanagan.math.Fmath
 
FND - Class in jhplot
Create a function in multiple dimensions.
FND(String, String, String) - Constructor for class jhplot.FND
Create a function in any dimension evaluation.
FND(String, String) - Constructor for class jhplot.FND
Build a function, setting its title to the definition.
FoldedNormalDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the folded normal distribution with parameters μ >=  0 and σ > 0.
FoldedNormalDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Constructs a FoldedNormalDist object with parameters μ = mu and σ = sigma.
FoldedNormalGen - Class in umontreal.iro.lecuyer.randvar
This class implements methods for generating random variates from the folded normal distribution with parameters μ >=  0 and σ > 0.
FoldedNormalGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.FoldedNormalGen
Creates a new folded normal generator with parameters μ = mu and σ = sigma, using stream s.
FoldedNormalGen(RandomStream, FoldedNormalDist) - Constructor for class umontreal.iro.lecuyer.randvar.FoldedNormalGen
Creates a new generator for the distribution dist, using stream s.
Folder - Class in hep.aida.ref.tree
A Folder is a managed object representing a directory in a tree.
FOLDER_MASK - Static variable in class hep.aida.ref.event.TreeEvent
 
footToMetre(double) - Static method in class flanagan.math.Conv
 
footToMetre(double) - Static method in class flanagan.math.Fmath
 
forEach(BooleanProcedure) - Method in class cern.colt.list.AbstractBooleanList
Applies a procedure to each element of the receiver, if any.
forEach(ByteProcedure) - Method in class cern.colt.list.AbstractByteList
Applies a procedure to each element of the receiver, if any.
forEach(CharProcedure) - Method in class cern.colt.list.AbstractCharList
Applies a procedure to each element of the receiver, if any.
forEach(DoubleProcedure) - Method in class cern.colt.list.AbstractDoubleList
Applies a procedure to each element of the receiver, if any.
forEach(FloatProcedure) - Method in class cern.colt.list.AbstractFloatList
Applies a procedure to each element of the receiver, if any.
forEach(IntProcedure) - Method in class cern.colt.list.AbstractIntList
Applies a procedure to each element of the receiver, if any.
forEach(LongProcedure) - Method in class cern.colt.list.AbstractLongList
Applies a procedure to each element of the receiver, if any.
forEach(ShortProcedure) - Method in class cern.colt.list.AbstractShortList
Applies a procedure to each element of the receiver, if any.
forEach(BooleanProcedure) - Method in class cern.colt.list.BooleanArrayList
Applies a procedure to each element of the receiver, if any.
forEach(ByteProcedure) - Method in class cern.colt.list.ByteArrayList
Applies a procedure to each element of the receiver, if any.
forEach(CharProcedure) - Method in class cern.colt.list.CharArrayList
Applies a procedure to each element of the receiver, if any.
forEach(DoubleProcedure) - Method in class cern.colt.list.DoubleArrayList
Applies a procedure to each element of the receiver, if any.
forEach(FloatProcedure) - Method in class cern.colt.list.FloatArrayList
Applies a procedure to each element of the receiver, if any.
forEach(IntProcedure) - Method in class cern.colt.list.IntArrayList
Applies a procedure to each element of the receiver, if any.
forEach(LongProcedure) - Method in class cern.colt.list.LongArrayList
Applies a procedure to each element of the receiver, if any.
forEach(ObjectProcedure) - Method in class cern.colt.list.ObjectArrayList
Applies a procedure to each element of the receiver, if any.
forEach(ShortProcedure) - Method in class cern.colt.list.ShortArrayList
Applies a procedure to each element of the receiver, if any.
forEach(BooleanProcedure) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Applies a procedure to each element of the receiver, if any.
forEach(BooleanProcedure) - Method in class cern.colt.list.tboolean.BooleanArrayList
Applies a procedure to each element of the receiver, if any.
forEach(ByteProcedure) - Method in class cern.colt.list.tbyte.AbstractByteList
Applies a procedure to each element of the receiver, if any.
forEach(ByteProcedure) - Method in class cern.colt.list.tbyte.ByteArrayList
Applies a procedure to each element of the receiver, if any.
forEach(CharProcedure) - Method in class cern.colt.list.tchar.AbstractCharList
Applies a procedure to each element of the receiver, if any.
forEach(CharProcedure) - Method in class cern.colt.list.tchar.CharArrayList
Applies a procedure to each element of the receiver, if any.
forEach(DoubleProcedure) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Applies a procedure to each element of the receiver, if any.
forEach(DoubleProcedure) - Method in class cern.colt.list.tdouble.DoubleArrayList
Applies a procedure to each element of the receiver, if any.
forEach(FloatProcedure) - Method in class cern.colt.list.tfloat.AbstractFloatList
Applies a procedure to each element of the receiver, if any.
forEach(FloatProcedure) - Method in class cern.colt.list.tfloat.FloatArrayList
Applies a procedure to each element of the receiver, if any.
forEach(IntProcedure) - Method in class cern.colt.list.tint.AbstractIntList
Applies a procedure to each element of the receiver, if any.
forEach(IntProcedure) - Method in class cern.colt.list.tint.IntArrayList
Applies a procedure to each element of the receiver, if any.
forEach(LongProcedure) - Method in class cern.colt.list.tlong.AbstractLongList
Applies a procedure to each element of the receiver, if any.
forEach(LongProcedure) - Method in class cern.colt.list.tlong.LongArrayList
Applies a procedure to each element of the receiver, if any.
forEach(ObjectProcedure) - Method in class cern.colt.list.tobject.ObjectArrayList
Applies a procedure to each element of the receiver, if any.
forEach(ShortProcedure) - Method in class cern.colt.list.tshort.AbstractShortList
Applies a procedure to each element of the receiver, if any.
forEach(ShortProcedure) - Method in class cern.colt.list.tshort.ShortArrayList
Applies a procedure to each element of the receiver, if any.
forEach(DoubleProcedure) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Applies a procedure to each element of the receiver, if any.
forEach(DoubleProcedure) - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Applies a procedure to each element of the receiver, if any.
forEach(DoubleProcedure) - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Applies a procedure to each element of the receiver, if any.
forEach(FloatProcedure) - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Applies a procedure to each element of the receiver, if any.
forEachCoordinateInState(boolean, IntIntProcedure) - Method in class cern.colt.bitvector.BitMatrix
Applies a procedure to each coordinate that holds a bit in the given state.
forEachCoordinateInState(boolean, IntIntProcedure) - Method in class cern.colt.matrix.tbit.BitMatrix
Applies a procedure to each coordinate that holds a bit in the given state.
forEachIndexFromToInState(int, int, boolean, IntProcedure) - Method in class cern.colt.bitvector.BitVector
Applies a procedure to each bit index within the specified range that holds a bit in the given state.
forEachIndexFromToInState(int, int, boolean, IntProcedure) - Method in class cern.colt.matrix.tbit.BitVector
Applies a procedure to each bit index within the specified range that holds a bit in the given state.
forEachKey(DoubleProcedure) - Method in class cern.colt.map.AbstractDoubleIntMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.AbstractIntDoubleMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.AbstractIntIntMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.AbstractIntObjectMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.AbstractLongObjectMap
Applies a procedure to each key of the receiver, if any.
forEachKey(DoubleProcedure) - Method in class cern.colt.map.OpenDoubleIntHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.OpenIntDoubleHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.OpenIntIntHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.OpenIntObjectHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.OpenLongObjectHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(DoubleProcedure) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Applies a procedure to each key of the receiver, if any.
forEachKey(DoubleProcedure) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Applies a procedure to each key of the receiver, if any.
forEachKey(DoubleProcedure) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(DoubleProcedure) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(FloatProcedure) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Applies a procedure to each key of the receiver, if any.
forEachKey(FloatProcedure) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Applies a procedure to each key of the receiver, if any.
forEachKey(FloatProcedure) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(FloatProcedure) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.tint.AbstractIntIntMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Applies a procedure to each key of the receiver, if any.
forEachKey(IntProcedure) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Applies a procedure to each key of the receiver, if any.
forEachKey(LongProcedure) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Applies a procedure to each key of the receiver, if any.
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.DoubleMatrix2D
Assigns the result of a function to each non-zero cell; x[row,col] = function(x[row,col]).
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
 
forEachNonZero(IntIntDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Assigns the result of a function to each non-zero cell.
forEachNonZero(IntIntDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
forEachNonZero(IntIntDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
forEachNonZero(IntIntDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
forEachNonZero(IntIntDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
forEachNonZero(IntIntDComplexFunction) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Assigns the result of a function to each non-zero cell; x[row,col] = function(x[row,col]).
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
forEachNonZero(IntIntDoubleFunction) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
forEachNonZero(IntIntFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Assigns the result of a function to each non-zero cell.
forEachNonZero(IntIntFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
forEachNonZero(IntIntFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
forEachNonZero(IntIntFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
forEachNonZero(IntIntFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
forEachNonZero(IntIntFComplexFunction) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
forEachNonZero(IntIntFloatFunction) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Assigns the result of a function to each non-zero cell; x[row,col] = function(x[row,col]).
forEachNonZero(IntIntFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
forEachNonZero(IntIntFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
forEachNonZero(IntIntFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
forEachNonZero(IntIntFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
forEachNonZero(IntIntFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
forEachNonZero(IntIntFloatFunction) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
forEachNonZero(IntIntIntFunction) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
forEachNonZero(IntIntIntFunction) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
forEachNonZero(IntIntIntFunction) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
forEachNonZero(IntIntIntFunction) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
forEachNonZero(IntIntIntFunction) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
forEachNonZero(IntIntIntFunction) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
forEachNonZero(IntIntIntFunction) - Method in class cern.colt.matrix.tint.IntMatrix2D
Assigns the result of a function to each non-zero cell; x[row,col] = function(x[row,col]).
forEachNonZero(IntIntLongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
forEachNonZero(IntIntLongFunction) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
forEachNonZero(IntIntLongFunction) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
forEachNonZero(IntIntLongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
forEachNonZero(IntIntLongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
forEachNonZero(IntIntLongFunction) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
forEachNonZero(IntIntLongFunction) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Assigns the result of a function to each non-zero cell; x[row,col] = function(x[row,col]).
forEachNonZero(IntIntObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
forEachNonZero(IntIntObjectFunction) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
forEachNonZero(IntIntObjectFunction) - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
forEachNonZero(IntIntObjectFunction) - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
forEachNonZero(IntIntObjectFunction) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Assigns the result of a function to each non-zero cell; x[row,col] = function(x[row,col]).
forEachPair(DoubleIntProcedure) - Method in class cern.colt.map.AbstractDoubleIntMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntDoubleProcedure) - Method in class cern.colt.map.AbstractIntDoubleMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntIntProcedure) - Method in class cern.colt.map.AbstractIntIntMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntObjectProcedure) - Method in class cern.colt.map.AbstractIntObjectMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongObjectProcedure) - Method in class cern.colt.map.AbstractLongObjectMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(DoubleIntProcedure) - Method in class cern.colt.map.OpenDoubleIntHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntDoubleProcedure) - Method in class cern.colt.map.OpenIntDoubleHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntIntProcedure) - Method in class cern.colt.map.OpenIntIntHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntObjectProcedure) - Method in class cern.colt.map.OpenIntObjectHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongObjectProcedure) - Method in class cern.colt.map.OpenLongObjectHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(DoubleIntProcedure) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(DoubleLongProcedure) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntDoubleProcedure) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongDoubleProcedure) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(DoubleIntProcedure) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(DoubleLongProcedure) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntDoubleProcedure) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongDoubleProcedure) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(FloatIntProcedure) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(FloatLongProcedure) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntFloatProcedure) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongFloatProcedure) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(FloatIntProcedure) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(FloatLongProcedure) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntFloatProcedure) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongFloatProcedure) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntIntProcedure) - Method in class cern.colt.map.tint.AbstractIntIntMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntIntProcedure) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntLongProcedure) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongIntProcedure) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongLongProcedure) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntLongProcedure) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongIntProcedure) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongLongProcedure) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntObjectProcedure) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongObjectProcedure) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(IntObjectProcedure) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
forEachPair(LongObjectProcedure) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Applies a procedure to each (key,value) pair of the receiver, if any.
foreward(IntegralFunction, double, double, int) - Static method in class flanagan.integration.Integration
 
form(double) - Method in interface cern.colt.matrix.Former
Formats a double into a string (like sprintf in C).
form(float) - Method in interface cern.colt.matrix.Former
Formats a float into a string (like sprintf in C).
form(int) - Method in interface cern.colt.matrix.Former
Formats an int into a string (like sprintf in C).
form(long) - Method in interface cern.colt.matrix.Former
Formats an long into a string (like sprintf in C).
form(double[]) - Method in interface cern.colt.matrix.Former
Formats a complex (double[]) into a string (like sprintf in C).
form(float[]) - Method in interface cern.colt.matrix.Former
Formats a complex (float[]) into a string (like sprintf in C).
form(double) - Method in interface cern.colt.matrix.impl.Former
Formats a double into a string (like sprintf in C).
format(DoubleMatrix2D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string representations of all cells; no alignment considered.
format(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Returns a string representations of all cells; no alignment considered.
format(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Returns a string representations of all cells; no alignment considered.
format(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntFormatter
Returns a string representations of all cells; no alignment considered.
format(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongFormatter
Returns a string representations of all cells; no alignment considered.
format(Complex, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Formats a Complex object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Formats a object to produce a string.
format(double, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.AbstractFormat
Formats a double value as a fraction and appends the result to a StringBuffer.
format(long, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.AbstractFormat
Formats a long value as a fraction and appends the result to a StringBuffer.
format(BigFraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.BigFractionFormat
Formats a BigFraction object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.BigFractionFormat
Formats an object and appends the result to a StringBuffer.
format(Fraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.FractionFormat
Formats a Fraction object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.FractionFormat
Formats an object and appends the result to a StringBuffer.
format(BigFraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.ProperBigFractionFormat
Formats a BigFraction object to produce a string.
format(Fraction, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.fraction.ProperFractionFormat
Formats a Fraction object to produce a string.
format(Vector3D, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.geometry.Vector3DFormat
Formats a Vector3D object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.geometry.Vector3DFormat
Formats a object to produce a string.
format(RealVector, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.linear.RealVectorFormat
Formats a RealVector object to produce a string.
format(Object, StringBuffer, FieldPosition) - Method in class org.apache.commons.math.linear.RealVectorFormat
Formats a object to produce a string.
format() - Method in class umontreal.iro.lecuyer.util.AbstractChrono
Converts the CPU time used by the program since its last call to init for this AbstractChrono to a String in the HH:MM:SS.xx format.
format(double) - Static method in class umontreal.iro.lecuyer.util.AbstractChrono
Converts the time time, given in seconds, to a String in the HH:MM:SS.xx format.
format(long) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as d (0, 1, x).
format(int, long) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Converts a long integer to a String with a minimum length of fieldwidth, the result is right-padded with spaces if necessary but it is not truncated.
format(int, int, int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Returns a String containing x.
format(Locale, int, int, int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
This method is equivalent to format, except it formats the given value for the locale locale.
format(int[], int, int, int, int) - Static method in class umontreal.iro.lecuyer.util.TableFormat
Formats a String containing the elements n1 to n2 (inclusive) of table V, k elements per line, p positions per element.
format(double[], int, int, int, int, int, int) - Static method in class umontreal.iro.lecuyer.util.TableFormat
Similar to the previous method, but for an array of double's.
format(int[][], int, int, int, int, int, int, int, String) - Static method in class umontreal.iro.lecuyer.util.TableFormat
Formats a submatrix of integers.
format(double[][], int, int, int, int, int, int, int, String) - Static method in class umontreal.iro.lecuyer.util.TableFormat
Formats the submatrix with lines i1  <= i <=  i2 and columns j1  <= j <=  j2 of the matrix Mat, using the formatting style style.
formatActiveTests(int, double[], double[]) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Gets the p-values of the active EDF test statistics, which are in activeTests.
formatBase(int, long) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as formatBase (0, b, x).
formatBase(int, int, long) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Converts the integer x to a String representation in base b.
formatBase(int, int, int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Converts x to a String representation in base b using formatting similar to the f methods.
formatBigFraction(BigFraction) - Static method in class org.apache.commons.math.fraction.BigFractionFormat
This static method calls formatBigFraction() on a default instance of BigFractionFormat.
formatChi2(int, int, double) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Computes the p-value of the chi-square statistic chi2 for a test with k intervals.
formatCINormal(double, int) - Method in class umontreal.iro.lecuyer.stat.Tally
.
formatCINormal(double) - Method in class umontreal.iro.lecuyer.stat.Tally
Equivalent to formatCINormal (level, 3).
formatCIStudent(double, int) - Method in class umontreal.iro.lecuyer.stat.Tally
.
formatCIStudent(double) - Method in class umontreal.iro.lecuyer.stat.Tally
Equivalent to formatCIStudent (level, 3).
formatCIVarianceChi2(double, int) - Method in class umontreal.iro.lecuyer.stat.Tally
.
formatComplex(Complex) - Static method in class org.apache.commons.math.complex.ComplexFormat
This static method calls Format.format(Object) on a default instance of ComplexFormat.
formatConfidenceIntervalNormal(double, int) - Method in class umontreal.iro.lecuyer.stat.Tally
Deprecated. 
formatConfidenceIntervalNormal(double) - Method in class umontreal.iro.lecuyer.stat.Tally
Deprecated. 
formatConfidenceIntervalStudent(double, int) - Method in class umontreal.iro.lecuyer.stat.Tally
Deprecated. 
formatConfidenceIntervalStudent(double) - Method in class umontreal.iro.lecuyer.stat.Tally
Deprecated. 
formatFraction(Fraction) - Static method in class org.apache.commons.math.fraction.FractionFormat
This static method calls formatFraction() on a default instance of FractionFormat.
formatKS(int, double, double, double) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Computes the p-values of the three Kolmogorov-Smirnov statistics DN+, DN-, and DN, whose values are in dp, dm, d, respectively, assuming a sample of size n.
formatKS(DoubleArrayList, ContinuousDistribution) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Computes the KS test statistics to compare the empirical distribution of the observations in data with the theoretical distribution dist and formats the results.
formatKSJumpOne(int, double, double) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Similar to formatKS, but for the KS statistic DN+(a).
formatKSJumpOne(DoubleArrayList, ContinuousDistribution, double) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Similar to formatKS, but for DN+(a).
formatNumber(double, int) - Method in class jhplot.jadraw.JaAxes
formats a double precision number such that it is correctly rounded for output.
formatp0(double) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Returns the significance level (or p-value) p of a test, in the format ``1 - p'' if p is close to 1, and p otherwise.
formatp1(double) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Returns the string ``Significance level of test : '', then calls formatp0 to print p, and adds the marker ``****'' if p is considered suspect (uses the environment variable RSUSPECTP for this).
formatp2(double, double) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Returns x on a single line, then go to the next line and calls formatp1.
formatp3(String, double, double) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Formats the test statistic x for a test named testName with p-value p.
formatPoints() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet
 
formatPoints() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2
 
formatPoints() - Method in class umontreal.iro.lecuyer.hups.PointSet
Same as invoking formatPoints(n, d) with n and d equal to the number of points and the dimension of this object, respectively.
formatPoints(int, int) - Method in class umontreal.iro.lecuyer.hups.PointSet
Formats a string that displays the same information as returned by toString, together with the first d coordinates of the first n points.
formatPoints(PointSetIterator) - Method in class umontreal.iro.lecuyer.hups.PointSet
Same as invoking formatPoints(iter, n, d) with n and d equal to the number of points and the dimension, respectively.
formatPoints(PointSetIterator, int, int) - Method in class umontreal.iro.lecuyer.hups.PointSet
Same as invoking formatPoints(n, d), but prints the points by calling iter repeatedly.
formatPointsBase(int) - Method in class umontreal.iro.lecuyer.hups.PointSet
Similar to formatPoints(), but the points coordinates are printed in base b.
formatPointsBase(int, int, int) - Method in class umontreal.iro.lecuyer.hups.PointSet
Similar to formatPoints(n, d), but the points coordinates are printed in base b.
formatPointsBase(PointSetIterator, int) - Method in class umontreal.iro.lecuyer.hups.PointSet
Similar to formatPoints(iter), but the points coordinates are printed in base b.
formatPointsBase(PointSetIterator, int, int, int) - Method in class umontreal.iro.lecuyer.hups.PointSet
Similar to formatPoints(iter, n, d), but the points coordinates are printed in base b.
formatPointsNumbered() - Method in class umontreal.iro.lecuyer.hups.PointSet
Same as invoking formatPointsNumbered(n, d) with n and d equal to the number of points and the dimension, respectively.
formatPointsNumbered(int, int) - Method in class umontreal.iro.lecuyer.hups.PointSet
Same as invoking formatPoints(n,d), except that the points are numbered.
formatRealVector(RealVector) - Static method in class org.apache.commons.math.linear.RealVectorFormat
This static method calls Format.format(Object) on a default instance of RealVectorFormat.
formatState() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
formatState() - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
Deprecated. 
formatStateFull() - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
Deprecated. 
Formatter - Class in cern.colt.matrix.doublealgo
Flexible, well human readable matrix print formatting; By default decimal point aligned.
Formatter() - Constructor for class cern.colt.matrix.doublealgo.Formatter
Constructs and returns a matrix formatter with format "%G".
Formatter(String) - Constructor for class cern.colt.matrix.doublealgo.Formatter
Constructs and returns a matrix formatter.
Formatter - Class in cern.colt.matrix.objectalgo
Flexible, well human readable matrix print formatting.
Formatter() - Constructor for class cern.colt.matrix.objectalgo.Formatter
Constructs and returns a matrix formatter with alignment LEFT.
Formatter(String) - Constructor for class cern.colt.matrix.objectalgo.Formatter
Constructs and returns a matrix formatter.
formatVector3D(Vector3D) - Static method in class org.apache.commons.math.geometry.Vector3DFormat
This static method calls Format.format(Object) on a default instance of Vector3DFormat.
formatWithError(int, int, int, int, double, double, String[]) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Stores a string containing x into res[0], and a string containing error into res[1], both strings being formatted with the same notation.
formatWithError(int, int, int, double, double, String[]) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Stores a string containing x into res[0], and a string containing error into res[1], both strings being formatted with the same notation.
formatWithError(Locale, int, int, int, int, double, double, String[]) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
This method is equivalent to formatWithError, except that it formats the given value and error for the locale locale.
formatWithError(Locale, int, int, int, double, double, String[]) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
This method is equivalent to formatWithError, except that it formats the given value and error for the locale locale.
Former - Interface in cern.colt.matrix
Formats a double or complex (double[]) into a string (like sprintf in C).
Former - Interface in cern.colt.matrix.impl
Formats a double into a string (like sprintf in C).
FormerFactory - Class in cern.colt.matrix
Factory producing implementations of Former via method create(); Serves to isolate the interface of String formatting from the actual implementation.
FormerFactory() - Constructor for class cern.colt.matrix.FormerFactory
 
FormerFactory - Class in cern.colt.matrix.impl
Factory producing implementations of Former via method create(); Implementations of can use existing libraries such as corejava.PrintfFormat or corejava.Format or other.
FormerFactory() - Constructor for class cern.colt.matrix.impl.FormerFactory
 
forward() - Method in class flanagan.integration.Integration
 
forward(int) - Method in class flanagan.integration.Integration
 
forward(IntegralFunction, double, double, int) - Static method in class flanagan.integration.Integration
 
forwardSolve(DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Solves the lower triangular system U*x=b;
forwardSolve(FloatMatrix2D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Solves the lower triangular system U*x=b;
FOUR_FIFTHS - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "4/5".
FOUR_FIFTHS - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "4/5".
FourierTransform - Class in flanagan.math
 
FourierTransform() - Constructor for class flanagan.math.FourierTransform
 
FourierTransform(double[]) - Constructor for class flanagan.math.FourierTransform
 
FourierTransform(Complex[]) - Constructor for class flanagan.math.FourierTransform
 
fourthJuly() - Method in class flanagan.math.TimeAndDate
 
fourthJuly(int) - Method in class flanagan.math.TimeAndDate
 
FourthMoment - Class in org.apache.commons.math.stat.descriptive.moment
Computes a statistic related to the Fourth Central Moment.
FourthMoment() - Constructor for class org.apache.commons.math.stat.descriptive.moment.FourthMoment
Create a FourthMoment instance
FourthMoment(FourthMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.FourthMoment
Copy constructor, creates a new FourthMoment identical to the original
fourthOrder(DerivFunction) - Method in class flanagan.integration.RungeKutta
 
fourthOrder(DerivFunction, double, double, double, double) - Static method in class flanagan.integration.RungeKutta
 
fourthOrder(DerivnFunction) - Method in class flanagan.integration.RungeKutta
 
fourthOrder(DerivnFunction, double, double[], double, double) - Static method in class flanagan.integration.RungeKutta
 
fPDF(double, int, int) - Method in class flanagan.analysis.Stat
 
fPDF(double, int, double, int) - Method in class flanagan.analysis.Stat
 
FPMIN - Static variable in class flanagan.analysis.Stat
 
FPR - Class in jhplot
Class to build parametric functions using two independent variables, u and v.
FPR(String, String, int, int) - Constructor for class jhplot.FPR
Create a parametric function.
FPR(String, int, int) - Constructor for class jhplot.FPR
Create a parametric function.
FPR(String) - Constructor for class jhplot.FPR
Create a parametric function.
Fraction - Class in org.apache.commons.math.fraction
Representation of a rational number.
Fraction(double) - Constructor for class org.apache.commons.math.fraction.Fraction
Create a fraction given the double value.
Fraction(double, double, int) - Constructor for class org.apache.commons.math.fraction.Fraction
Create a fraction given the double value and maximum error allowed.
Fraction(double, int) - Constructor for class org.apache.commons.math.fraction.Fraction
Create a fraction given the double value and maximum denominator.
Fraction(int) - Constructor for class org.apache.commons.math.fraction.Fraction
Create a fraction from an int.
Fraction(int, int) - Constructor for class org.apache.commons.math.fraction.Fraction
Create a fraction given the numerator and denominator.
FractionConversionException - Exception in org.apache.commons.math.fraction
Error thrown when a double value cannot be converted to a fraction in the allowed number of iterations.
FractionConversionException(double, int) - Constructor for exception org.apache.commons.math.fraction.FractionConversionException
Constructs an exception with specified formatted detail message.
FractionConversionException(double, long, long) - Constructor for exception org.apache.commons.math.fraction.FractionConversionException
Constructs an exception with specified formatted detail message.
FractionField - Class in org.apache.commons.math.fraction
Representation of the fractional numbers field.
FractionFormat - Class in org.apache.commons.math.fraction
Formats a Fraction number in proper format or improper format.
FractionFormat() - Constructor for class org.apache.commons.math.fraction.FractionFormat
Create an improper formatting instance with the default number format for the numerator and denominator.
FractionFormat(NumberFormat) - Constructor for class org.apache.commons.math.fraction.FractionFormat
Create an improper formatting instance with a custom number format for both the numerator and denominator.
FractionFormat(NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math.fraction.FractionFormat
Create an improper formatting instance with a custom number format for the numerator and a custom number format for the denominator.
fractionMatrixToRealMatrix(FieldMatrix<Fraction>) - Static method in class org.apache.commons.math.linear.MatrixUtils
Convert a FieldMatrix/Fraction matrix to a RealMatrix.
FRand - Class in cern.jet.random.tfloat.engine
Quick medium quality uniform pseudo-random number generator.
FRand() - Constructor for class cern.jet.random.tfloat.engine.FRand
Constructs and returns a random number generator with a default seed, which is a constant.
FRand(int) - Constructor for class cern.jet.random.tfloat.engine.FRand
Constructs and returns a random number generator with the given seed.
FRand(Date) - Constructor for class cern.jet.random.tfloat.engine.FRand
Constructs and returns a random number generator seeded with the given date.
fRand(int, int, int) - Static method in class flanagan.analysis.Stat
 
fRand(int, int, int, long) - Static method in class flanagan.analysis.Stat
 
FRandomVariable - Class in jhplot.math.num.random
A random variable generator for the F distribution.
FRandomVariable() - Constructor for class jhplot.math.num.random.FRandomVariable
Default constructor.
FRandomVariable(double, double) - Constructor for class jhplot.math.num.random.FRandomVariable
Create a random variable with the given numerator degrees of freedom and denominator degrees of freedom.
FRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.FRandomVariable
Create a random variable with the given parameters.
frechet() - Method in class flanagan.analysis.Regression
 
frechet(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
frechetArray(double, double, double, int) - Method in class flanagan.math.PsRandom
 
frechetCDF(double, double, double, double, double) - Static method in class flanagan.analysis.Stat
 
frechetCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
FrechetDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Fréchet distribution, with location parameter δ, scale parameter β > 0, and shape parameter α > 0, where we use the notation z = (x - δ)/β.
FrechetDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.FrechetDist
Constructor for the standard Fréchet distribution with parameters β = 1 and δ = 0.
FrechetDist(double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.FrechetDist
Constructs a FrechetDist object with parameters α = alpha, β = beta and δ = delta.
frechetGamma() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetGammaError() - Method in class flanagan.analysis.ProbabilityPlot
 
FrechetGen - Class in umontreal.iro.lecuyer.randvar
This class implements methods for generating random variates from the Fréchet distribution, with location parameter δ, scale parameter β > 0, and shape parameter α > 0, where we use the notation z = (x - δ)/β.
FrechetGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.FrechetGen
Creates a Fréchet random number generator with α = alpha, β = 1 and δ = 0 using stream s.
FrechetGen(RandomStream, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.FrechetGen
Creates a Fréchet random number generator with parameters α = alpha, β = beta and δ = delta using stream s.
FrechetGen(RandomStream, FrechetDist) - Constructor for class umontreal.iro.lecuyer.randvar.FrechetGen
Creates a new generator for the Fréchet distribution dist and stream s.
frechetGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetInverseCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
frechetInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
frechetInverseCDF(double, double) - Static method in class flanagan.analysis.Stat
 
frechetMean(double, double, double) - Static method in class flanagan.analysis.Stat
 
frechetMode(double, double, double) - Static method in class flanagan.analysis.Stat
 
frechetMu() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetMuError() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetOrderStatisticMedians(double, double, double, int) - Static method in class flanagan.analysis.Stat
 
frechetOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
frechetOrderStatisticMedians(double, int) - Static method in class flanagan.analysis.Stat
 
frechetPDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
frechetPlot() - Method in class flanagan.analysis.Regression
 
frechetProb(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
frechetProb(double, double, double, double, double) - Static method in class flanagan.analysis.Stat
 
frechetProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetRand(double, double, double, int) - Static method in class flanagan.analysis.Stat
 
frechetRand(double, double, double, int, long) - Static method in class flanagan.analysis.Stat
 
frechetSigma() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetSigmaError() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetStandard() - Method in class flanagan.analysis.Regression
 
frechetStandardDeviation(double, double) - Static method in class flanagan.analysis.Stat
 
frechetStandardPlot() - Method in class flanagan.analysis.Regression
 
frechetStandDev(double, double) - Static method in class flanagan.analysis.Stat
 
frechetSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
frechetTwoPar() - Method in class flanagan.analysis.Regression
 
frechetTwoParPlot() - Method in class flanagan.analysis.Regression
 
frequencies(DoubleArrayList, IntArrayList) - Method in class cern.hep.aida.bin.DynamicBin1D
Computes the frequency (number of occurances, count) of each distinct element.
frequencies(DoubleArrayList, DoubleArrayList, IntArrayList) - Static method in class cern.jet.stat.Descriptive
Computes the frequency (number of occurances, count) of each distinct value in the given sorted data.
frequencies(DoubleArrayList, DoubleArrayList, IntArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Computes the frequency (number of occurances, count) of each distinct value in the given sorted data.
frequencies(FloatArrayList, FloatArrayList, IntArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Computes the frequency (number of occurances, count) of each distinct value in the given sorted data.
frequencies(DoubleArrayList, IntArrayList) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Computes the frequency (number of occurances, count) of each distinct element.
frequencies(FloatArrayList, IntArrayList) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Computes the frequency (number of occurances, count) of each distinct element.
Frequency - Class in org.apache.commons.math.stat
Maintains a frequency distribution.
Frequency() - Constructor for class org.apache.commons.math.stat.Frequency
Default constructor.
Frequency(Comparator<?>) - Constructor for class org.apache.commons.math.stat.Frequency
Constructor allowing values Comparator to be specified.
frequencyToRadialFrequency(double) - Static method in class flanagan.math.Conv
 
frequencyToRadialFrequency(double) - Static method in class flanagan.math.Fmath
 
frobeniusNorm() - Method in class flanagan.math.Matrix
 
fromCSV(String) - Static method in class umontreal.iro.lecuyer.charts.PlotFormat
Parses data according to the standard CSV format and stores the extracted values in the returned table.
fromCustomizedFormat(String, String, String) - Static method in class umontreal.iro.lecuyer.charts.PlotFormat
Parses data according to a user defined format and stores the extracted values in the returned table.
fromGNUPlot(String) - Static method in class umontreal.iro.lecuyer.charts.PlotFormat
Parses data according to the standard GNUPlot format and stores the extracted values in the returned table.
fromXML(String) - Static method in class jhplot.io.Serialized
Get object to XML using XSream package
fTestProb(double, int, int) - Static method in class flanagan.analysis.Stat
 
fTestProb(double, int, double, int) - Static method in class flanagan.analysis.Stat
 
fTestValueGivenFprob(double, int, int) - Static method in class flanagan.analysis.Stat
 
FTuple - Interface in hep.aida.ref.tuple
 
fTuple() - Method in interface hep.aida.ref.tuple.HasFTuple
 
fTuple() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
FTupleAdapter - Class in hep.aida.ref.tuple
 
FTupleAdapter(ITuple) - Constructor for class hep.aida.ref.tuple.FTupleAdapter
 
FTupleColumn - Interface in hep.aida.ref.tuple
 
FTupleCursor - Interface in hep.aida.ref.tuple
 
FTupleEvent - Interface in hep.aida.ref.tuple
 
fullPathKey - Static variable in class hep.aida.ref.Annotation
 
func(F1D) - Method in class jhplot.P0D
Transform P0D array to array with values given by a function.
func(String, F1D) - Method in class jhplot.P0D
Make transformation of P0D using a function.
func(F1D) - Method in class jhplot.P0I
Transform P0I array to array with values given by a function.
func(String, F1D) - Method in class jhplot.P0I
Make transformation of P0I using a function.
funcF() - Method in class jhplot.HPlot
Return FunctionFactory associated with the plot
funcF() - Method in class jhplot.HPlotJa
Return FunctionFactory associated with the plot
function(double) - Method in class flanagan.analysis.LogNormalThreeParFunct
 
function(double[], double[], int) - Method in interface flanagan.analysis.RegressionDerivativeFunction
 
function(double[], double[], int, int) - Method in interface flanagan.analysis.RegressionDerivativeFunction2
 
function(double[], double[]) - Method in interface flanagan.analysis.RegressionFunction
 
function(double[], double[], int) - Method in interface flanagan.analysis.RegressionFunction2
 
function(double) - Method in interface flanagan.integration.IntegralFunction
 
function(double[]) - Method in interface flanagan.math.MaximisationFunction
 
function(double[]) - Method in interface flanagan.math.MaximizationFunction
 
function(double[]) - Method in interface flanagan.math.MinimisationFunction
 
function(double[]) - Method in interface flanagan.math.MinimizationFunction
 
function(int) - Method in class hep.aida.ref.function.SumOfFunctions
 
Function - Interface in jhplot.math
BSD License
Function - Interface in jhplot.math.num
A single variable function.
FunctionCatalog - Class in hep.aida.ref.function
 
functionChanged(FunctionChangedEvent) - Method in interface hep.aida.ref.function.FunctionListener
 
FunctionChangedEvent - Class in hep.aida.ref.function
 
FunctionChangedEvent(int) - Constructor for class hep.aida.ref.function.FunctionChangedEvent
 
FunctionCore - Class in hep.aida.ref.function
 
FunctionCore(int, int) - Constructor for class hep.aida.ref.function.FunctionCore
 
FunctionCore(int, int, double[]) - Constructor for class hep.aida.ref.function.FunctionCore
 
FunctionCoreListener - Interface in hep.aida.ref.function
 
FunctionCreator - Class in hep.aida.ref.function
Singleton class that is used by FunctionFactory and FunctionCatalog to create functions from codelet strings.
FunctionCreator() - Constructor for class hep.aida.ref.function.FunctionCreator
 
FunctionDispatcher - Interface in hep.aida.ref.function
 
FunctionEvaluationException - Exception in org.apache.commons.math
Exception thrown when an error occurs evaluating a function.
FunctionEvaluationException(double) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Construct an exception indicating the argument value that caused the function evaluation to fail.
FunctionEvaluationException(double[]) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Construct an exception indicating the argument value that caused the function evaluation to fail.
FunctionEvaluationException(double, String, Object...) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified formatted detail message.
FunctionEvaluationException(double, Localizable, Object...) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified formatted detail message.
FunctionEvaluationException(double[], String, Object...) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified formatted detail message.
FunctionEvaluationException(double[], Localizable, Object...) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified formatted detail message.
FunctionEvaluationException(Throwable, double) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified root cause.
FunctionEvaluationException(Throwable, double[]) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified root cause.
FunctionEvaluationException(Throwable, double, String, Object...) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified formatted detail message and root cause.
FunctionEvaluationException(Throwable, double, Localizable, Object...) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified formatted detail message and root cause.
FunctionEvaluationException(Throwable, double[], String, Object...) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified formatted detail message and root cause.
FunctionEvaluationException(Throwable, double[], Localizable, Object...) - Constructor for exception org.apache.commons.math.FunctionEvaluationException
Constructs an exception with specified formatted detail message and root cause.
FunctionFactory - Class in hep.aida.ref.function
 
FunctionFactory(ITree) - Constructor for class hep.aida.ref.function.FunctionFactory
Create a new FunctionFactory.
FunctionIntegrator - Class in hep.aida.ref.function
 
FunctionIntegrator() - Constructor for class hep.aida.ref.function.FunctionIntegrator
Creates a new instance of FunctionIntegrator
FunctionListener - Interface in hep.aida.ref.function
 
functions - Static variable in class cern.hep.aida.bin.BinFunctions1D
Little trick to allow for "aliasing", that is, renaming this class.
Functions - Class in cern.jet.math
Function objects to be passed to generic methods.
functions - Static variable in class cern.jet.math.Functions
Little trick to allow for "aliasing", that is, renaming this class.
functions - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
functions - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Little trick to allow for "aliasing", that is, renaming this class.
functions - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
functions - Static variable in class cern.jet.math.tfloat.FloatFunctions
Little trick to allow for "aliasing", that is, renaming this class.
functions - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Little trick to allow for "aliasing", that is, renaming this class.
functions - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Little trick to allow for "aliasing", that is, renaming this class.
FunctionUtils - Class in hep.aida.ref.function
 
FunctionUtils() - Constructor for class hep.aida.ref.function.FunctionUtils
 
functionValue(double[]) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
functionValue(double[]) - Method in class hep.aida.ref.function.BaseModelFunction
 
functionValue(double[]) - Method in class hep.aida.ref.function.ExponentialCoreNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.ExponentialCoreNotNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.ExponentModelFunction
 
functionValue(double[]) - Method in class hep.aida.ref.function.FunctionCore
 
functionValue(double[]) - Method in class hep.aida.ref.function.GaussianCore2DNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.GaussianCore2DNotNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.GaussianCoreNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.GaussianCoreNotNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.JELFunctionCore
 
functionValue(double[]) - Method in class hep.aida.ref.function.LorentzianCoreNotNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.MoyalCoreNotNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.PolynomialCoreNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.PolynomialCoreNotNorm
 
functionValue(double[]) - Method in class hep.aida.ref.function.PolynomialModelFunction
 

G

g - Static variable in class cern.clhep.Units
 
g(double, double[]) - Method in interface org.apache.commons.math.ode.events.EventHandler
Compute the value of the switching function.
g(double, double[], double[][], double[][]) - Method in interface org.apache.commons.math.ode.jacobians.EventHandlerWithJacobians
Deprecated. Compute the value of the switching function.
G(double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as G (0, 6, x).
G(int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as G (fieldwidth, 6, x).
G(int, int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Formats the double-precision x into a string like %G in C printf.
g(double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as g (0, 6, x).
g(int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as g (fieldwidth, 6, x).
g(int, int, double) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
The same as G, except that `e' is used in the scientific notation.
gallonPerMileToLitrePerKm(double) - Static method in class flanagan.math.Conv
 
gallonPerMileToLitrePerKm(double) - Static method in class flanagan.math.Fmath
 
gallonToLitre(double) - Static method in class flanagan.math.Conv
 
gallonToLitre(double) - Static method in class flanagan.math.Fmath
 
gallonUKtoUS(double) - Static method in class flanagan.math.Conv
 
gallonUKtoUS(double) - Static method in class flanagan.math.Fmath
 
gallonUStoUK(double) - Static method in class flanagan.math.Conv
 
gallonUStoUK(double) - Static method in class flanagan.math.Fmath
 
Gamma - Class in cern.jet.random
Gamma distribution; math definition, definition of gamma function and animated definition.
Gamma(double, double, RandomEngine) - Constructor for class cern.jet.random.Gamma
Constructs a Gamma distribution.
Gamma - Class in cern.jet.random.tdouble
Gamma distribution; math definition, definition of gamma function and animated definition.
Gamma(double, double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.Gamma
Constructs a Gamma distribution.
Gamma - Class in cern.jet.stat
Gamma and Beta functions.
gamma(double) - Static method in class cern.jet.stat.Gamma
Returns the Gamma function of the argument.
gamma(double, double, double) - Static method in class cern.jet.stat.Probability
Returns the integral from zero to x of the gamma probability density function.
Gamma - Class in cern.jet.stat.tdouble
Gamma and Beta functions.
gamma(double) - Static method in class cern.jet.stat.tdouble.Gamma
Returns the Gamma function of the argument.
gamma(double, double, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the integral from zero to x of the gamma probability density function.
gamma - Variable in class flanagan.analysis.LogNormalThreeParFunct
 
gamma() - Method in class flanagan.analysis.Regression
 
gamma(double) - Static method in class flanagan.analysis.Stat
 
Gamma - Class in jhplot.math.num.pdf
The Gamma distribution (1).
Gamma() - Constructor for class jhplot.math.num.pdf.Gamma
Default constructor.
Gamma(double, double) - Constructor for class jhplot.math.num.pdf.Gamma
Create a distribution with the given alpha and beta values.
Gamma - Class in jhplot.math.num.special
Utility class that provides methods related to the gamma family of functions.
Gamma - Class in org.apache.commons.math.special
This is a utility class that provides computation methods related to the Gamma family of functions.
GAMMA - Static variable in class org.apache.commons.math.special.Gamma
Euler-Mascheroni constant
GammaAcceptanceRejectionGen - Class in umontreal.iro.lecuyer.randvar
This class implements gamma random variate generators using a method that combines acceptance-rejection with acceptance-complement.
GammaAcceptanceRejectionGen(RandomStream, RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.GammaAcceptanceRejectionGen
Creates a gamma random variate generator with parameters α = alpha and λ = lambda, using main stream s and auxiliary stream aux.
GammaAcceptanceRejectionGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.GammaAcceptanceRejectionGen
Creates a gamma random variate generator with parameters α = alpha and λ = lambda, using stream s.
GammaAcceptanceRejectionGen(RandomStream, RandomStream, GammaDist) - Constructor for class umontreal.iro.lecuyer.randvar.GammaAcceptanceRejectionGen
Creates a new generator object for the gamma distribution dist, using main stream s and auxiliary stream aux.
GammaAcceptanceRejectionGen(RandomStream, GammaDist) - Constructor for class umontreal.iro.lecuyer.randvar.GammaAcceptanceRejectionGen
Creates a new generator object for the gamma distribution dist and stream s for both the main and auxiliary stream.
gammaArray(double, double, double, int) - Method in class flanagan.math.PsRandom
 
gammaCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
gammaCDF(double, double) - Static method in class flanagan.analysis.Stat
 
gammaComplemented(double, double, double) - Static method in class cern.jet.stat.Probability
Returns the integral from x to infinity of the gamma probability density function:
gammaComplemented(double, double, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the integral from x to infinity of the gamma probability density function:
GammaDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the gamma distribution with shape parameter α > 0 and scale parameter λ > 0.
GammaDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.GammaDist
Constructs a GammaDist object with parameters α = alpha and λ = 1.
GammaDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.GammaDist
Constructs a GammaDist object with parameters α = alpha and λ = lambda.
GammaDist(double, double, int) - Constructor for class umontreal.iro.lecuyer.probdist.GammaDist
Constructs a GammaDist object with parameters α = alpha and λ = lambda, and approximations of roughly d decimal digits of precision when computing functions.
GammaDistFromMoments - Class in umontreal.iro.lecuyer.probdist
Extends the GammaDist distribution with constructors accepting the mean μ and variance σ2 as arguments instead of a shape parameter α and a scale parameter λ.
GammaDistFromMoments(double, double, int) - Constructor for class umontreal.iro.lecuyer.probdist.GammaDistFromMoments
Constructs a gamma distribution with mean mean, variance var, and d decimal of precision.
GammaDistFromMoments(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.GammaDistFromMoments
Constructs a gamma distribution with mean mean, and variance var.
GammaDistribution - Interface in org.apache.commons.math.distribution
The Gamma Distribution.
GammaDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of GammaDistribution.
GammaDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.GammaDistributionImpl
Create a new gamma distribution with the given alpha and beta values.
GammaDistributionImpl(double, double, double) - Constructor for class org.apache.commons.math.distribution.GammaDistributionImpl
Create a new gamma distribution with the given alpha and beta values.
gammaFunction(double) - Static method in class flanagan.analysis.Stat
 
gammaFunctionMinimum() - Static method in class flanagan.analysis.Stat
 
GammaGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the gamma distribution.
GammaGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.GammaGen
Creates a gamma random variate generator with parameters α = alpha and λ = lambda, using stream s.
GammaGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.GammaGen
Creates a gamma random variate generator with parameters α = alpha and λ = 1, using stream s.
GammaGen(RandomStream, GammaDist) - Constructor for class umontreal.iro.lecuyer.randvar.GammaGen
Creates a new generator object for the gamma distribution dist and stream s.
gammaMean(double, double, double) - Static method in class flanagan.analysis.Stat
 
gammaMode(double, double, double) - Static method in class flanagan.analysis.Stat
 
gammaPDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
gammaPDF(double, double) - Static method in class flanagan.analysis.Stat
 
gammaPlot() - Method in class flanagan.analysis.Regression
 
GammaProcess - Class in umontreal.iro.lecuyer.stochprocess
This class represents a gamma process {S(t) = G(t;μ, ν) : t >= 0} with mean parameter μ and variance parameter ν.
GammaProcess(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.GammaProcess
Constructs a new GammaProcess with parameters μ = mu, ν = nu and initial value S(t0) = s0.
GammaProcess(double, double, double, GammaGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.GammaProcess
Constructs a new GammaProcess with parameters μ = mu, ν = nu and initial value S(t0) = s0.
GammaProcessBridge - Class in umontreal.iro.lecuyer.stochprocess
This class represents a gamma process {S(t) = G(t;μ, ν) : t >= 0} with mean parameter μ and variance parameter ν, sampled using the gamma bridge method (see for example).
GammaProcessBridge(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.GammaProcessBridge
Constructs a new GammaProcessBridge with parameters μ = mu, ν = nu and initial value S(t0) = s0.
GammaProcessBridge(double, double, double, GammaGen, BetaGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.GammaProcessBridge
Constructs a new GammaProcessBridge.
GammaProcessPCA - Class in umontreal.iro.lecuyer.stochprocess
Represents a gamma process sampled using the principal component analysis (PCA).
GammaProcessPCA(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.GammaProcessPCA
Constructs a new GammaProcessPCA with parameters μ = mu, ν = nu and initial value S(t0) = s0.
GammaProcessPCA(double, double, double, GammaGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.GammaProcessPCA
Constructs a new GammaProcessPCA with parameters μ = mu, ν = nu and initial value S(t0) = s0.
GammaProcessPCABridge - Class in umontreal.iro.lecuyer.stochprocess
Same as GammaProcessPCA, but the generated uniforms correspond to a bridge transformation of the BrownianMotionPCA instead of a sequential transformation.
GammaProcessPCABridge(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.GammaProcessPCABridge
Constructs a new GammaProcessPCABridge with parameters μ = mu, ν = nu and initial value S(t0) = s0.
GammaProcessPCASymmetricalBridge - Class in umontreal.iro.lecuyer.stochprocess
Same as GammaProcessPCABridge, but uses the fast inversion method for the symmetrical beta distribution, proposed by L'Ecuyer and Simard, to accelerate the generation of the beta random variables.
GammaProcessPCASymmetricalBridge(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.GammaProcessPCASymmetricalBridge
Constructs a new GammaProcessPCASymmetricalBridge with parameters μ = mu, ν = nu and initial value S(t0) = s0.
GammaProcessSymmetricalBridge - Class in umontreal.iro.lecuyer.stochprocess
This class differs from GammaProcessBridge only in that it requires the number of interval of the path to be a power of 2 and of equal size.
GammaProcessSymmetricalBridge(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.GammaProcessSymmetricalBridge
Constructs a new GammaProcessSymmetricalBridge with parameters μ = mu, ν = nu and initial value S(t0) = s0.
GammaProcessSymmetricalBridge(double, double, double, GammaGen, BetaSymmetricalGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.GammaProcessSymmetricalBridge
Constructs a new GammaProcessSymmetricalBridge with parameters μ = mu, ν = nu and initial value S(t0) = s0.
gammaRand(double, double, double, int) - Static method in class flanagan.analysis.Stat
 
gammaRand(double, double, double, int, long) - Static method in class flanagan.analysis.Stat
 
GammaRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Gamma distribution.
GammaRandomVariable() - Constructor for class jhplot.math.num.random.GammaRandomVariable
Default constructor.
GammaRandomVariable(double, double) - Constructor for class jhplot.math.num.random.GammaRandomVariable
Create a random variable with the given alpha and beta values.
GammaRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.GammaRandomVariable
Create a random variable with the given parameters.
gammaRatioHalf(double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of the ratio Γ(x + 1/2)/Γ(x) of two gamma functions, evaluated in a numerically stable way.
GammaRejectionLoglogisticGen - Class in umontreal.iro.lecuyer.randvar
This class implements gamma random variate generators using a rejection method with loglogistic envelopes,.
GammaRejectionLoglogisticGen(RandomStream, RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.GammaRejectionLoglogisticGen
Creates a gamma random variate generator with parameters α = alpha and λ = lambda, using main stream s and auxiliary stream aux.
GammaRejectionLoglogisticGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.GammaRejectionLoglogisticGen
Creates a gamma random variate generator with parameters α = alpha and λ = lambda, using stream s.
GammaRejectionLoglogisticGen(RandomStream, RandomStream, GammaDist) - Constructor for class umontreal.iro.lecuyer.randvar.GammaRejectionLoglogisticGen
Creates a new generator object for the gamma distribution dist, using main stream s and auxiliary stream aux.
GammaRejectionLoglogisticGen(RandomStream, GammaDist) - Constructor for class umontreal.iro.lecuyer.randvar.GammaRejectionLoglogisticGen
Creates a new generator object for the gamma distribution dist and stream s for both the main and auxiliary stream.
gammaStandard() - Method in class flanagan.analysis.Regression
 
gammaStandardDeviation(double, double, double) - Static method in class flanagan.analysis.Stat
 
gammaStandardPlot() - Method in class flanagan.analysis.Regression
 
gammaStandDev(double, double, double) - Static method in class flanagan.analysis.Stat
 
GArc(float, float, float, float, float, float) - Static method in class jhplot.jadraw.Diagram
Get a g-line object
gauss - Static variable in class cern.clhep.Units
 
Gauss - Class in jhplot.fit
Gaussian distribution.
Gauss() - Constructor for class jhplot.fit.Gauss
 
Gauss(String) - Constructor for class jhplot.fit.Gauss
 
Gauss(String[], String[]) - Constructor for class jhplot.fit.Gauss
 
gaussian() - Method in class flanagan.analysis.Regression
 
gaussian(double[], boolean[]) - Method in class flanagan.analysis.Regression
 
gaussian(double, double, double) - Static method in class flanagan.analysis.Stat
 
gaussian4(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using the Gaussian integration formula (4 points).
gaussian8(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using the Gaussian integration formula (8 points).
GAUSSIAN_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Gaussian random deviates with mean = μ, std dev = σ.
gaussianArray(double, double, int) - Method in class flanagan.math.PsRandom
 
GaussianBinError - Class in hep.aida.ref.dataset.binner
This class calculates the error on the bin assuming a gaussian distribution.
GaussianBinError() - Constructor for class hep.aida.ref.dataset.binner.GaussianBinError
 
gaussianCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
gaussianCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
GaussianCore2DNorm - Class in hep.aida.ref.function
Not normalised Gaussian 2D (G2) distribution in the form: f = (1/N)*exp(-(x-meanX)^2/(2*sigmaX^2))*exp(-(y-meanY)^2/(2*sigmaY^2)) has 4 parameters Normalization Amplitude is calculated by the "normalizationAmplitude" method
GaussianCore2DNorm(String) - Constructor for class hep.aida.ref.function.GaussianCore2DNorm
 
GaussianCore2DNorm(String, double[]) - Constructor for class hep.aida.ref.function.GaussianCore2DNorm
 
GaussianCore2DNotNorm - Class in hep.aida.ref.function
Not normalised Gaussian 2D (G2) distribution in the form: f = (amplitude)*exp(-(x-meanX)^2/(2*sigmaX^2))*exp(-(y-meanY)^2/(2*sigmaY^2)) has 5 parameters
GaussianCore2DNotNorm(String) - Constructor for class hep.aida.ref.function.GaussianCore2DNotNorm
 
GaussianCore2DNotNorm(String, double[]) - Constructor for class hep.aida.ref.function.GaussianCore2DNotNorm
 
GaussianCoreNorm - Class in hep.aida.ref.function
Not normalised Gaussian (G) distribution in the form: f = (1/N)*exp(-(x-mean)^2/(2*sigma^2)) has 2 parameters Normalization Amplitude is calculated by the "normalizationAmplitude" method
GaussianCoreNorm(String) - Constructor for class hep.aida.ref.function.GaussianCoreNorm
 
GaussianCoreNorm(String, double[]) - Constructor for class hep.aida.ref.function.GaussianCoreNorm
 
GaussianCoreNotNorm - Class in hep.aida.ref.function
Not normalised Gaussian (G) distribution in the form: f = amplitude*exp(-(x-mean)^2/(2*sigma^2)) has 3 parameters
GaussianCoreNotNorm(String) - Constructor for class hep.aida.ref.function.GaussianCoreNotNorm
 
GaussianCoreNotNorm(String, double[]) - Constructor for class hep.aida.ref.function.GaussianCoreNotNorm
 
gaussianCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
GaussianDerivativeFunction - Class in org.apache.commons.math.optimization.fitting
The derivative of GaussianFunction.
GaussianDerivativeFunction(double, double, double) - Constructor for class org.apache.commons.math.optimization.fitting.GaussianDerivativeFunction
Constructs an instance with the specified parameters.
GaussianDerivativeFunction(double[]) - Constructor for class org.apache.commons.math.optimization.fitting.GaussianDerivativeFunction
Constructs an instance with the specified parameters.
GaussianFitter - Class in org.apache.commons.math.optimization.fitting
Fits points to a Gaussian function (that is, a GaussianFunction).
GaussianFitter(DifferentiableMultivariateVectorialOptimizer) - Constructor for class org.apache.commons.math.optimization.fitting.GaussianFitter
Constructs an instance using the specified optimizer.
GaussianFunction - Class in org.apache.commons.math.optimization.fitting
A Gaussian function.
GaussianFunction(double, double, double, double) - Constructor for class org.apache.commons.math.optimization.fitting.GaussianFunction
Constructs an instance with the specified parameters.
GaussianFunction(double[]) - Constructor for class org.apache.commons.math.optimization.fitting.GaussianFunction
Constructs an instance with the specified parameters.
gaussianGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
gaussianInverseCDF(double) - Static method in class flanagan.analysis.Stat
 
gaussianMu() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianMuError() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
gaussianOrderStatisticMedians(int) - Static method in class flanagan.analysis.Stat
 
GaussianParametersGuesser - Class in org.apache.commons.math.optimization.fitting
Guesses the parameters (a, b, c, and d) of a ParametricGaussianFunction based on the specified observed points.
GaussianParametersGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math.optimization.fitting.GaussianParametersGuesser
Constructs instance with the specified observed points.
gaussianPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
gaussianPlot() - Method in class flanagan.analysis.Regression
 
gaussianPlot(double[], boolean[]) - Method in class flanagan.analysis.Regression
 
gaussianProb(double, double, double) - Static method in class flanagan.analysis.Stat
 
gaussianProb(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
gaussianProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
gaussianRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
GaussianRandomGenerator - Class in org.apache.commons.math.random
This class is a gaussian normalized random generator for scalars.
GaussianRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math.random.GaussianRandomGenerator
Create a new generator.
gaussianSigma() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianSigmaError() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianStandardCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianStandardGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianStandardGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianStandardIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianStandardInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianStandardOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianStandardProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianStandardSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussianUnweightedSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
gaussLobatto(MathFunction, double, double, double) - Static method in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Computes and returns a numerical approximation of the integral of f (x) over [a, b], using Gauss-Lobatto adaptive quadrature with 5 nodes, with tolerance tol.
gaussLobatto(MathFunction, double, double, double, double[][]) - Static method in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Similar to method gaussLobatto(MathFunction, double, double, double), but also returns in T[0] the subintervals of integration, and in T[1], the partial values of the integral over the corresponding subintervals.
GaussNewtonEstimator - Class in org.apache.commons.math.estimation
Deprecated. as of 2.0, everything in package org.apache.commons.math.estimation has been deprecated and replaced by package org.apache.commons.math.optimization.general
GaussNewtonEstimator() - Constructor for class org.apache.commons.math.estimation.GaussNewtonEstimator
Deprecated. Simple constructor with default settings.
GaussNewtonEstimator(int, double, double) - Constructor for class org.apache.commons.math.estimation.GaussNewtonEstimator
Deprecated. Simple constructor.
GaussNewtonOptimizer - Class in org.apache.commons.math.optimization.general
Gauss-Newton least-squares solver.
GaussNewtonOptimizer(boolean) - Constructor for class org.apache.commons.math.optimization.general.GaussNewtonOptimizer
Simple constructor with default settings.
gaussQuad() - Method in class flanagan.integration.Integration
 
gaussQuad(int) - Method in class flanagan.integration.Integration
 
gaussQuad(IntegralFunction, double, double, int) - Static method in class flanagan.integration.Integration
 
gaussQuadCoeff(double[], double[], int) - Static method in class flanagan.integration.Integration
 
gcd(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Gets the greatest common divisor of the absolute value of two numbers, using the "binary gcd" method which avoids division and modulo operations.
gcd(long, long) - Static method in class org.apache.commons.math.util.MathUtils
Gets the greatest common divisor of the absolute value of two numbers, using the "binary gcd" method which avoids division and modulo operations.
gcd(int, int) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the greatest common divisor (gcd) of x and y.
gcd(long, long) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the greatest common divisor (gcd) of x and y.
geData() - Method in class jhplot.HChart
Returns the current data object
generalisedEntropyOneNat(double, double) - Method in class flanagan.analysis.Stat
 
generalisedEntropyOneNat(double[], double, double) - Static method in class flanagan.analysis.Stat
 
generalisedMean(double) - Method in class flanagan.analysis.Stat
 
generalisedMean(BigDecimal) - Method in class flanagan.analysis.Stat
 
generalisedMean(Complex[], double) - Static method in class flanagan.analysis.Stat
 
generalisedMean(Complex[], Complex) - Static method in class flanagan.analysis.Stat
 
generalisedMean(BigDecimal[], double) - Static method in class flanagan.analysis.Stat
 
generalisedMean(BigDecimal[], BigDecimal) - Static method in class flanagan.analysis.Stat
 
generalisedMean(BigInteger[], double) - Static method in class flanagan.analysis.Stat
 
generalisedMean(BigInteger[], BigInteger) - Static method in class flanagan.analysis.Stat
 
generalisedMean(double[], double) - Static method in class flanagan.analysis.Stat
 
generalisedMean(float[], float) - Static method in class flanagan.analysis.Stat
 
generalisedMean(Complex[], Complex[], double) - Static method in class flanagan.analysis.Stat
 
generalisedMean(Complex[], Complex[], Complex) - Static method in class flanagan.analysis.Stat
 
generalisedMean(BigDecimal[], BigDecimal[], double) - Static method in class flanagan.analysis.Stat
 
generalisedMean(BigDecimal[], BigDecimal[], BigDecimal) - Static method in class flanagan.analysis.Stat
 
generalisedMean(BigInteger[], BigInteger[], double) - Static method in class flanagan.analysis.Stat
 
generalisedMean(BigInteger[], BigInteger[], BigInteger) - Static method in class flanagan.analysis.Stat
 
generalisedMean(double[], double[], double) - Static method in class flanagan.analysis.Stat
 
generalisedMean(float[], float[], float) - Static method in class flanagan.analysis.Stat
 
generalisedMean_as_Complex(double) - Method in class flanagan.analysis.Stat
 
generalisedMean_as_Complex(Complex) - Method in class flanagan.analysis.Stat
 
generalisedMean_as_double(double) - Method in class flanagan.analysis.Stat
 
generalisedMean_as_double(BigDecimal) - Method in class flanagan.analysis.Stat
 
generalizedEntropyOneNat(double, double) - Method in class flanagan.analysis.Stat
 
generalizedEntropyOneNat(double[], double, double) - Static method in class flanagan.analysis.Stat
 
generalizedMean(double) - Method in class flanagan.analysis.Stat
 
generalizedMean(BigDecimal) - Method in class flanagan.analysis.Stat
 
generalizedMean(Complex[], double) - Static method in class flanagan.analysis.Stat
 
generalizedMean(Complex[], Complex) - Static method in class flanagan.analysis.Stat
 
generalizedMean(BigDecimal[], double) - Static method in class flanagan.analysis.Stat
 
generalizedMean(BigDecimal[], BigDecimal) - Static method in class flanagan.analysis.Stat
 
generalizedMean(BigInteger[], double) - Static method in class flanagan.analysis.Stat
 
generalizedMean(BigInteger[], BigInteger) - Static method in class flanagan.analysis.Stat
 
generalizedMean(double[], double) - Static method in class flanagan.analysis.Stat
 
generalizedMean(float[], float) - Static method in class flanagan.analysis.Stat
 
generalizedMean_as_Complex(double) - Method in class flanagan.analysis.Stat
 
generalizedMean_as_Complex(Complex) - Method in class flanagan.analysis.Stat
 
generalizedMean_as_double(double) - Method in class flanagan.analysis.Stat
 
generalizedMean_as_double(BigDecimal) - Method in class flanagan.analysis.Stat
 
generateNonSingular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Modifies the given matrix square matrix A such that it is diagonally dominant by row and column, hence non-singular, hence invertible.
generateNonSingular(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Modifies the given matrix square matrix A such that it is diagonally dominant by row and column, hence non-singular, hence invertible.
generateNonSingular(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Modifies the given matrix square matrix A such that it is diagonally dominant by row and column, hence non-singular, hence invertible.
generateNonSingular(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
Modifies the given matrix square matrix A such that it is diagonally dominant by row and column, hence non-singular, hence invertible.
generateNonSingular(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Modifies the given matrix square matrix A such that it is diagonally dominant by row and column, hence non-singular, hence invertible.
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Same as generatePath(), but a vector of uniform random numbers must be provided to the method.
generatePath(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionBridge
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionBridge
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCA
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCA
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCAEqualSteps
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCAEqualSteps
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
 
generatePath(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
 
generatePath(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcess
Generates, returns and saves the path {X(t0), X(t1),…, X(td)}.
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcess
Generates, returns and saves the path {X(t0), X(t1),…, X(td)}.
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessBridge
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessBridge
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCA
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCA
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCABridge
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCABridge
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCASymmetricalBridge
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCASymmetricalBridge
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessSymmetricalBridge
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessSymmetricalBridge
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
 
generatePath(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Generates a path.
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
Instead of using the internal stream to generate the path, uses an array of uniforms U[0, 1).
generatePath(double[], double[]) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
This method does not work for this class, but will be useful for the subclasses that require two streams.
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessBridge
Generates the path.
generatePath(double[], double[]) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessBridge
Instead of using the internal streams to generate the path, it uses two arrays of uniforms U[0, 1).
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Generates the path.
generatePath(double[], double[]) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Instead of using the internal streams to generate the path, uses two arrays of uniforms U[0, 1).
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Not implemented, requires two RandomStream's.
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessPCA
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessPCA
Instead of using the internal stream to generate the path, uses an array of uniforms U[0, 1).
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Generates the path.
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
 
generatePath(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
 
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcessEuler
Generates a sample path of the process at all observation times, which are provided in array t.
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Generates, returns, and saves the sample path {X(t0), X(t1),…, X(td)}.
generatePath(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Same as generatePath(), but first resets the stream to stream.
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Generates and returns the path.
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Similar to the usual generatePath(), but here the uniform random numbers used for the simulation must be provided to the method.
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
Generates, returns and saves the path.
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
Similar to the usual generatePath(), but here the uniform random numbers used for the simulation must be provided to the method.
generatePath() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiffPCA
 
generatePath(double[]) - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiffPCA
 
generatePoint() - Method in class hep.aida.ref.function.RangeSet
 
GenericFactory - Class in hep.aida.ref
 
GenericFactory(String) - Constructor for class hep.aida.ref.GenericFactory
 
genericPartition(int, int, int, int, int[], IntComparator, IntComparator, IntComparator, Swapper) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it generically partitions arbitrary shaped data (for example matrices or multiple arrays) rather than int[] arrays.
GenericPermuting - Class in cern.colt
Generically reorders (permutes) arbitrary shaped data (for example, an array, three arrays, a 2-d matrix, two linked lists) using an in-place swapping algorithm.
GenericSorting - Class in cern.colt
Generically sorts arbitrary shaped data (for example multiple arrays, 1,2 or 3-d matrices, and so on) using a quicksort or mergesort.
GeneticAlgorithm - Class in org.apache.commons.math.genetics
Implementation of a genetic algorithm.
GeneticAlgorithm(CrossoverPolicy, double, MutationPolicy, double, SelectionPolicy) - Constructor for class org.apache.commons.math.genetics.GeneticAlgorithm
 
GenF2w32 - Class in umontreal.iro.lecuyer.rng
Implements the RandomStream interface via inheritance from RandomStreamBase.
GenF2w32() - Constructor for class umontreal.iro.lecuyer.rng.GenF2w32
Constructs a new stream.
GenF2w32(String) - Constructor for class umontreal.iro.lecuyer.rng.GenF2w32
Constructs a new stream with the identifier name (used in the toString method).
Geometric - Class in jhplot.math.num.pdf
The Geometric distribution.
Geometric() - Constructor for class jhplot.math.num.pdf.Geometric
Default constructor.
Geometric(double) - Constructor for class jhplot.math.num.pdf.Geometric
Create a distribution with the given probability of success.
GeometricBrownianMotion - Class in umontreal.iro.lecuyer.stochprocess
.
GeometricBrownianMotion(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
Same as GeometricBrownianMotion (s0, mu, sigma, new BrownianMotion (0.0, 0.0, 1.0, stream)).
GeometricBrownianMotion(double, double, double, BrownianMotion) - Constructor for class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
Constructs a new GeometricBrownianMotion with parameters μ = mu, σ = sigma, and S(t0) = s0, using bm as the underlying BrownianMotion.
GeometricDist - Class in umontreal.iro.lecuyer.probdist
Extends the class DiscreteDistributionInt for the geometric distribution with parameter p, where 0 < p < 1.
GeometricDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.GeometricDist
Constructs a geometric distribution with parameter p.
GeometricGen - Class in umontreal.iro.lecuyer.randvar
This class implements a random variate generator for the geometric distribution.
GeometricGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.GeometricGen
Creates a geometric random variate generator with parameter p, using stream s.
GeometricGen(RandomStream, GeometricDist) - Constructor for class umontreal.iro.lecuyer.randvar.GeometricGen
Creates a new generator for the distribution dist, using stream s.
GeometricLevyProcess - Class in umontreal.iro.lecuyer.stochprocess
.
GeometricLevyProcess() - Constructor for class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
 
geometricMean - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.geometricMean().
geometricMean() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the geometric mean, which is Product( x[i] )1.0/size().
geometricMean(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the geometric mean of a data sequence.
geometricMean(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the geometric mean of a data sequence.
geometricMean(int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the geometric mean of a data sequence.
geometricMean(DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the geometric mean of a data sequence.
geometricMean(int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the geometric mean of a data sequence.
geometricMean(FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the geometric mean of a data sequence.
geometricMean() - Method in class flanagan.analysis.Stat
 
geometricMean(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
geometricMean(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
geometricMean(Complex[]) - Static method in class flanagan.analysis.Stat
 
geometricMean(double[]) - Static method in class flanagan.analysis.Stat
 
geometricMean(float[]) - Static method in class flanagan.analysis.Stat
 
geometricMean(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
geometricMean(BigDecimal[], BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
geometricMean(BigInteger[], BigInteger[]) - Static method in class flanagan.analysis.Stat
 
geometricMean(double[], double[]) - Static method in class flanagan.analysis.Stat
 
geometricMean(float[], float[]) - Static method in class flanagan.analysis.Stat
 
geometricMean - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.geometricMean().
geometricMean() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the geometric mean, which is Product( x[i] )1.0/size().
geometricMean - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.geometricMean().
geometricMean() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the geometric mean, which is Product( x[i] )1.0/size().
GeometricMean - Class in org.apache.commons.math.stat.descriptive.moment
Returns the geometric mean of the available values.
GeometricMean() - Constructor for class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Create a GeometricMean instance
GeometricMean(GeometricMean) - Constructor for class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Copy constructor, creates a new GeometricMean identical to the original
GeometricMean(SumOfLogs) - Constructor for class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Create a GeometricMean instance using the given SumOfLogs instance
geometricMean(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the geometric mean of the entries in the input array, or Double.NaN if the array is empty.
geometricMean(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the geometric mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
geometricMean_as_Complex() - Method in class flanagan.analysis.Stat
 
geometricMean_as_double() - Method in class flanagan.analysis.Stat
 
GeometricNormalInverseGaussianProcess - Class in umontreal.iro.lecuyer.stochprocess
.
GeometricNormalInverseGaussianProcess(double, double, double, double, double, double, RandomStream, NormalInverseGaussianProcess) - Constructor for class umontreal.iro.lecuyer.stochprocess.GeometricNormalInverseGaussianProcess
Constructs a new GeometricNormalInverseGaussianProcess.
GeometricNormalInverseGaussianProcess(double, double, double, double, double, double, RandomStream, InverseGaussianProcess) - Constructor for class umontreal.iro.lecuyer.stochprocess.GeometricNormalInverseGaussianProcess
Constructs a new GeometricNormalInverseGaussianProcess.
GeometricNormalInverseGaussianProcess(double, double, double, double, double, double, RandomStream, RandomStream, RandomStream, String) - Constructor for class umontreal.iro.lecuyer.stochprocess.GeometricNormalInverseGaussianProcess
Constructs a new GeometricNormalInverseGaussianProcess.
GeometricNormalInverseGaussianProcess(double, double, double, double, double, double, RandomStream, String) - Constructor for class umontreal.iro.lecuyer.stochprocess.GeometricNormalInverseGaussianProcess
Constructs a new GeometricNormalInverseGaussianProcess.
geometricPdf(int, double) - Static method in class cern.jet.random.Distributions
Returns the probability distribution function of the discrete geometric distribution.
geometricPdf(int, double) - Static method in class cern.jet.random.tdouble.Distributions
Returns the probability distribution function of the discrete geometric distribution.
GeometricRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Geometric distribution.
GeometricRandomVariable() - Constructor for class jhplot.math.num.random.GeometricRandomVariable
Default constructor.
GeometricRandomVariable(double) - Constructor for class jhplot.math.num.random.GeometricRandomVariable
Create a random variable with the given probability of success.
GeometricRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.GeometricRandomVariable
Create a random variable with the given parameters.
GeometricVarianceGammaProcess - Class in umontreal.iro.lecuyer.stochprocess
This class represents a geometric variance gamma process S(t) (see).
GeometricVarianceGammaProcess(double, double, double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
Constructs a new GeometricVarianceGammaProcess with parameters θ = theta, σ = sigma, ν = nu, μ = mu and initial value S(t0) = s0.
GeometricVarianceGammaProcess(double, double, VarianceGammaProcess) - Constructor for class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
Constructs a new GeometricVarianceGammaProcess.
get(int, int) - Method in class cern.colt.bitvector.BitMatrix
Returns from the receiver the value of the bit at the specified coordinate.
get(int) - Method in class cern.colt.bitvector.BitVector
Returns from the bitvector the value of the bit with the specified index.
get(long[], int) - Static method in class cern.colt.bitvector.QuickBitVector
Returns from the bitvector the value of the bit with the specified index.
get(int) - Method in class cern.colt.list.AbstractBooleanList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractByteList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractCharList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractDoubleList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractFloatList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractIntList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractLongList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.AbstractShortList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.adapter.DoubleListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.adapter.FloatListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.adapter.IntListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.adapter.LongListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.adapter.ObjectListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.BooleanArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.ByteArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.CharArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.DoubleArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.FloatArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.IntArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.LongArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.ObjectArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.ShortArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tbyte.AbstractByteList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tbyte.ByteArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tchar.AbstractCharList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tchar.CharArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tdouble.DoubleArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tdouble.DoubleListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tfloat.FloatArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tfloat.FloatListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.tint.AbstractIntList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tint.IntArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tint.IntListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.tlong.AbstractLongList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tlong.LongArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tlong.LongListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.tobject.ObjectArrayList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tobject.ObjectListAdapter
Returns the element at the specified position in this list.
get(int) - Method in class cern.colt.list.tshort.AbstractShortList
Returns the element at the specified position in the receiver.
get(int) - Method in class cern.colt.list.tshort.ShortArrayList
Returns the element at the specified position in the receiver.
get(double) - Method in class cern.colt.map.AbstractDoubleIntMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.AbstractIntDoubleMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.AbstractIntIntMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.AbstractIntObjectMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.AbstractLongObjectMap
Returns the value associated with the specified key.
get(double) - Method in class cern.colt.map.OpenDoubleIntHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.OpenIntDoubleHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.OpenIntIntHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.OpenIntObjectHashMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.OpenLongObjectHashMap
Returns the value associated with the specified key.
get(double) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Returns the value associated with the specified key.
get(double) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Returns the value associated with the specified key.
get(double) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Returns the value associated with the specified key.
get(double) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Returns the value associated with the specified key.
get(float) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Returns the value associated with the specified key.
get(float) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Returns the value associated with the specified key.
get(float) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Returns the value associated with the specified key.
get(float) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.tint.AbstractIntIntMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Returns the value associated with the specified key.
get(long) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Returns the value associated with the specified key.
get(int) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.DoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get(int) - Method in class cern.colt.matrix.ObjectMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.ObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get(int, int) - Method in class cern.colt.matrix.tbit.BitMatrix
Returns from the receiver the value of the bit at the specified coordinate.
get(int) - Method in class cern.colt.matrix.tbit.BitVector
Returns from the bitvector the value of the bit with the specified index.
get(long[], int) - Static method in class cern.colt.matrix.tbit.QuickBitVector
Returns from the bitvector the value of the bit with the specified index.
get(int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get(int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get(int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get(int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Returns the matrix cell value at coordinate index.
get(int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
get(int, int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
get() - Method in class jhplot.H1D
Get JAIDA histogram
get() - Method in class jhplot.H2D
Get the JAIDA Histogram2D
get() - Method in class jhplot.HProf1D
Get JAIDA histogram
get() - Method in class jhplot.HProf2D
Get the JAIDA Profile2D
get(String) - Method in class jhplot.io.FileAida
Get object associated with the key name
get(String) - Method in class jhplot.io.FileRoot
Get object associated with the key name in the current directory.
get(String) - Method in class jhplot.io.HDataBase
Get object from the database using a key
get(int) - Method in class jhplot.math.num.DoubleArray
Access the element at the given index.
get(int, String) - Method in class jhplot.P0D
Get P0D with values below, above or equal a specified value.
get(int) - Method in class jhplot.P0D
Return a specific value at ith position.
get(int, String) - Method in class jhplot.P0I
Get P0I with values below, above or equal a specified value.
get(int) - Method in class jhplot.P0I
Return a specific value at ith position.
get(int) - Method in class jhplot.PND
Return a specific row as array
get(int, int) - Method in class jhplot.PND
Return a specific value.
get(int) - Method in class jhplot.PNI
Return a specific row as array
get(int, int) - Method in class jhplot.PNI
Return a specific value.
get() - Method in class jhplot.security.MD5
Returns 32-character hex representation of this objects hash
Get - Class in jminhep.cluster
Some useful methods related to the clustering procedure
Get() - Constructor for class jminhep.cluster.Get
 
get(int) - Method in class org.apache.commons.math.util.OpenIntToDoubleHashMap
Get the stored value associated with the given key
get(int) - Method in class org.apache.commons.math.util.OpenIntToFieldHashMap
Get the stored value associated with the given key
get() - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Gets the primary dataset.
get(int) - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Gets the element at the specified position in the dataset list.
get(int) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
get(int, int) - Method in class umontreal.iro.lecuyer.util.DMatrix
Returns the matrix element in the specified row and column.
get(int) - Method in class umontreal.iro.lecuyer.util.TransformingList
 
get3sProbability() - Method in class jhpro.stat.ConfidenceLevel
Get 3s probability.
get5sProbability() - Method in class jhpro.stat.ConfidenceLevel
Get 5s probability.
getA() - Method in class org.apache.commons.math.optimization.fitting.GaussianFunction
Gets a parameter value.
getA() - Method in class umontreal.iro.lecuyer.functions.PowerMathFunction
Returns the value of a.
getA() - Method in class umontreal.iro.lecuyer.functions.SquareMathFunction
Returns the value of a.
getA() - Method in class umontreal.iro.lecuyer.hups.KorobovLattice
Returns the multiplier a of the lattice.
geta() - Method in class umontreal.iro.lecuyer.hups.LCGPointSet
Returns the value of the multiplier a.
getA() - Method in class umontreal.iro.lecuyer.probdist.BetaDist
Returns the parameter a of this object.
getA() - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Returns the location parameter a of this object.
getA() - Method in class umontreal.iro.lecuyer.probdist.PowerDist
Returns the parameter a.
getA() - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
Returns the parameter a.
getA() - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
Returns the value of a for this object.
getA() - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Returns the value of a.
getA() - Method in class umontreal.iro.lecuyer.probdist.UniformDist
Returns the parameter a.
getA() - Method in class umontreal.iro.lecuyer.randvar.BetaGen
Returns the parameter a of this object.
getA() - Method in class umontreal.iro.lecuyer.randvar.NakagamiGen
Returns the location parameter a of this object.
getA() - Method in class umontreal.iro.lecuyer.randvar.PowerGen
Returns the parameter a.
getA() - Method in class umontreal.iro.lecuyer.randvar.RayleighGen
Returns the parameter a.
getA() - Method in class umontreal.iro.lecuyer.randvar.TriangularGen
Returns the value of a for this object.
getA() - Method in class umontreal.iro.lecuyer.randvar.UniformGen
Returns the value of a for this object.
getA1() - Method in class org.apache.commons.math.geometry.RotationOrder
Get the axis of the first rotation.
getA2() - Method in class org.apache.commons.math.geometry.RotationOrder
Get the axis of the second rotation.
getA3() - Method in class org.apache.commons.math.geometry.RotationOrder
Get the axis of the second rotation.
getAbsoluteAccuracy() - Method in interface org.apache.commons.math.ConvergingAlgorithm
Deprecated. Get the actual absolute accuracy.
getAbsoluteAccuracy() - Method in class org.apache.commons.math.ConvergingAlgorithmImpl
Deprecated. Get the actual absolute accuracy.
getAbsoluteAccuracy() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Get the actual absolute accuracy.
getAbsoluteTolerance() - Method in class cern.colt.matrix.tdouble.algo.solver.DefaultDoubleIterationMonitor
Returns the absolute convergence tolerance
getAbsoluteTolerance() - Method in class cern.colt.matrix.tfloat.algo.solver.DefaultFloatIterationMonitor
Returns the absolute convergence tolerance
getAdjustedR() - Method in class flanagan.analysis.Regression
 
getAdjustedR2() - Method in class flanagan.analysis.Regression
 
getAll() - Method in class jhplot.io.FileAida
Get list of all objects
getAllH1D() - Method in class jhplot.HBook
Get array with all H1D histograms.
getAllH2D() - Method in class jhplot.HBook
Get array with all H2D histograms.
getAllign() - Method in class jhplot.jadraw.JaLatexText
Returns the allign property of this text object.
getAllNames(String) - Method in class jhplot.io.FileAida
Get list of all objects
getAllNames() - Method in class jhplot.io.FileAida
Get list of all objects
getAllP1D() - Method in class jhplot.HBook
Get array with all P1D containers.
getAllParameters() - Method in interface org.apache.commons.math.estimation.EstimationProblem
Deprecated. Get all the parameters of the problem.
getAllParameters() - Method in class org.apache.commons.math.estimation.SimpleEstimationProblem
Deprecated. Get all the parameters of the problem.
getAllTypes() - Method in class jhplot.io.FileAida
Get list of all types
getAllTypes(String) - Method in class jhplot.io.FileAida
Get list of all types
getAlpha() - Method in class jhplot.bsom.Bsom
 
getAlpha() - Method in class jhplot.HBsom
Get alpha
getAlpha() - Method in class jhplot.math.num.pdf.Beta
Access the alpha parameter.
getAlpha() - Method in class jhplot.math.num.pdf.Gamma
Access the alpha parameter.
getAlpha() - Method in interface org.apache.commons.math.distribution.BetaDistribution
Access the shape parameter, alpha
getAlpha() - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
Access the shape parameter, alpha
getAlpha() - Method in interface org.apache.commons.math.distribution.GammaDistribution
Access the shape parameter, alpha
getAlpha() - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Access the shape parameter, alpha
getAlpha() - Method in class org.apache.commons.math.geometry.Vector3D
Get the azimuth of the vector.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.BetaDist
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
Returns the value of α for this object.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.GammaDist
Return the parameter α for this object.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Returns the α parameter of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
Return the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Return the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
Returns the parameter α.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Returns the α parameter of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
Returns the parameter α.
getAlpha() - Method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
Returns the parameters (α1,...,αd) of this object.
getAlpha(int) - Method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
Returns the ith component of the alpha vector.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.BetaGen
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.CauchyGen
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.ExtremeValueGen
Deprecated. Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.FrechetGen
Returns the parameter α.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.GammaGen
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.InverseGammaGen
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.LogisticGen
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.LoglogisticGen
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.NormalInverseGaussianGen
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.ParetoGen
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.Pearson5Gen
Returns the parameter α of this object.
getAlpha() - Method in class umontreal.iro.lecuyer.randvar.WeibullGen
Returns the parameter α.
getAlpha(int) - Method in class umontreal.iro.lecuyer.randvarmulti.DirichletGen
Returns the αi+1 parameter for this Dirichlet generator.
getAlpha() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
Returns the value of α.
getAlpha() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
Returns the value of α.
getAlpha() - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Returns alpha.
getAlpha() - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Returns the value of α.
getAlpha1() - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Returns the α1 parameter of this object.
getAlpha1() - Method in class umontreal.iro.lecuyer.randvar.Pearson6Gen
Returns the α1 parameter of this object.
getAlpha2() - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Returns the α2 parameter of this object.
getAlpha2() - Method in class umontreal.iro.lecuyer.randvar.Pearson6Gen
Returns the α2 parameter of this object.
getAlternateInputData() - Method in class flanagan.math.FourierTransform
 
getAlternateWindowedInputData() - Method in class flanagan.math.FourierTransform
 
getAmp() - Method in class jhplot.jadraw.JaArcObject
Returns the amp property of this arc object.
getAmp() - Method in class jhplot.jadraw.JaLineObject
Returns the amp property of this line object.
getAmp() - Method in class jhplot.jadraw.JaLoopObject
Returns the amp property of this loop object.
getAmplitude() - Method in class org.apache.commons.math.optimization.fitting.HarmonicFunction
Get the amplitude a.
getAnalyticAverage(double) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
Returns the analytic average which is δt/γ, with t = time.
getAnalyticAverage(double) - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Returns the analytic average, which is μt + δtβ/γ.
getAnalyticVariance(double) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
Returns the analytic variance which is (δt)2, with t = time.
getAnalyticVariance(double) - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Returns the analytic variance, which is δtα2/γ3.
getAngamp() - Method in class jhplot.jadraw.JaGlLine
Returns the angamp property of this JaGlLine.
getAngle() - Method in class jhpro.stat.EEcentricity
Returns angle of ellipse rotation (angle of the principial axis)
getAngle() - Method in class org.apache.commons.math.geometry.Rotation
Get the angle of the rotation.
getAngles(RotationOrder) - Method in class org.apache.commons.math.geometry.Rotation
Get the Cardan or Euler angles corresponding to the instance.
getAntiAlias() - Method in class jhplot.HPlot
Get antialiasing for the graphics of the current plot
getArcParameters() - Method in class jhplot.jadraw.JaArcObject
 
getArea() - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Returns the value of F0(b) - F0(a), the area under the truncated density function.
getArgument() - Method in class org.apache.commons.math.complex.Complex
Compute the argument of this complex number.
getArgument() - Method in exception org.apache.commons.math.exception.MathIllegalNumberException
 
getArgument() - Method in exception org.apache.commons.math.FunctionEvaluationException
Returns the function argument that caused this exception.
getArguments() - Method in exception org.apache.commons.math.exception.MathIllegalArgumentException
Gets the arguments used to build the message of this throwable.
getArguments() - Method in exception org.apache.commons.math.exception.MathIllegalStateException
Gets the arguments used to build the message of this throwable.
getArguments() - Method in interface org.apache.commons.math.exception.MathThrowable
Gets the arguments used to build the message of this throwable.
getArguments() - Method in exception org.apache.commons.math.exception.MathUnsupportedOperationException
Gets the arguments used to build the message of this throwable.
getArguments() - Method in exception org.apache.commons.math.MathException
Gets the arguments used to build the message of this throwable.
getArguments() - Method in exception org.apache.commons.math.MathRuntimeException
Gets the arguments used to build the message of this throwable.
getArity() - Method in class org.apache.commons.math.genetics.TournamentSelection
Gets the arity (number of chromosomes drawn to the tournament).
getArray() - Method in class jhplot.P0D
Get a double array with P0D values.
getArray() - Method in class jhplot.P0I
Get integer array with P0I values.
getArray() - Method in class jhplot.PND
Get a double array with values.
getArray() - Method in class jhplot.PNI
Get a double array with values.
getArray() - Method in class jminhep.cluster.DataHolder
Get the data in form of Array
getArray() - Method in class umontreal.iro.lecuyer.stat.TallyStore
Returns the observations stored in this probe.
getArray_as_ArrayList() - Method in class flanagan.math.ArrayMaths
 
getArray_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
getArray_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
getArray_as_byte() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Byte() - Method in class flanagan.math.ArrayMaths
 
getArray_as_char() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Character() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Complex() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Complex_columnMatrix() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Complex_rowMatrix() - Method in class flanagan.math.ArrayMaths
 
getArray_as_degrees_phase_of_Phasor() - Method in class flanagan.math.ArrayMaths
 
getArray_as_double() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Double() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Float() - Method in class flanagan.math.ArrayMaths
 
getArray_as_float() - Method in class flanagan.math.ArrayMaths
 
getArray_as_imaginay_part_of_Complex() - Method in class flanagan.math.ArrayMaths
 
getArray_as_int() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Integer() - Method in class flanagan.math.ArrayMaths
 
getArray_as_long() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Long() - Method in class flanagan.math.ArrayMaths
 
getArray_as_magnitude_of_Phasor() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Matrix_columnMatrix() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Matrix_rowMatrix() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Object() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Phasor() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Phasor_columnMatrix() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Phasor_rowMatrix() - Method in class flanagan.math.ArrayMaths
 
getArray_as_radians_phase_of_Phasor() - Method in class flanagan.math.ArrayMaths
 
getArray_as_real_part_of_Complex() - Method in class flanagan.math.ArrayMaths
 
getArray_as_short() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Short() - Method in class flanagan.math.ArrayMaths
 
getArray_as_String() - Method in class flanagan.math.ArrayMaths
 
getArray_as_Vector() - Method in class flanagan.math.ArrayMaths
 
getArrayCopy() - Method in class flanagan.math.Matrix
 
getArrayDouble() - Method in class jhplot.P0I
Get a double array with P0I values.
getArrayInt() - Method in class jhplot.P0D
Get an integer array with P0D values.
getArrayList() - Method in class jhplot.HPlotJa
Get list of all objects on the frame.
getArrayList() - Method in class jhplot.P0D
Get data in form of ArrayList
getArrayList() - Method in class jhplot.P0I
Get data in form of ArrayList
getArrayList() - Method in class jhplot.PND
Get data in form of ArrayList
getArrayList() - Method in class jhplot.PNI
Get data in form of ArrayList
getArrayList() - Method in class jminhep.cluster.DataHolder
Get all elements of the data holder in form of an ArrayList
getArrayMappingCounterToIndex() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns a reference to an array that maps an integer k to ik, the index of the observation S(tik) corresponding to the k-th observation to be generated for a sample path of this process.
getArrayPointer() - Method in class flanagan.math.Matrix
 
getArrayReference() - Method in class flanagan.math.Matrix
 
getArrayX() - Method in class jhplot.P1D
Get array representing X-values
getArrayX() - Method in class jhplot.P2D
Get array representing X-values
getArrayX() - Method in class jhplot.P3D
Get array representing X-values
getArrayXleft() - Method in class jhplot.P1D
Get array representing X-left errors
getArrayXleftSys() - Method in class jhplot.P1D
Get array representing X-left 2nd level errors
getArrayXright() - Method in class jhplot.P1D
Get array representing X-right errors
getArrayXrightSys() - Method in class jhplot.P1D
Get array representing X-right 2nd level errors
getArrayY() - Method in class jhplot.P1D
Get array representing Y-values
getArrayY() - Method in class jhplot.P2D
Get array representing Y-values
getArrayY() - Method in class jhplot.P3D
Get array representing Y-values
getArrayYlower() - Method in class jhplot.P1D
Get array representing Y lower errors
getArrayYlowerSys() - Method in class jhplot.P1D
Get array representing Y lower 2nd level errors
getArrayYupper() - Method in class jhplot.P1D
Get array representing Y upper errors
getArrayYupperSys() - Method in class jhplot.P1D
Get array representing Y upper 2nd level errors
getArrayZ() - Method in class jhplot.P2D
Get array representing Z-values
getArrayZ() - Method in class jhplot.P3D
Get array representing Z-values
getArrow() - Method in class jhplot.jadraw.JaArcObject
Returns the arrow property of this arc object.
getArrow() - Method in class jhplot.jadraw.JaLineObject
Returns the arrow property of this line object.
getArrow() - Method in class jhplot.jadraw.JaLoopObject
Returns the arrow property of this loop object.
getAs() - Method in class umontreal.iro.lecuyer.hups.Rank1Lattice
Returns the generator aj of the lattice.
getAttribute(int) - Method in class jminhep.cluster.DataPoint
Returns the attribute of data point
getAuthor() - Static method in class jhplot.JHPlot
Get the author
getAuxStream() - Method in class umontreal.iro.lecuyer.randvar.BetaRejectionLoglogisticGen
Returns the auxiliary stream associated with that object.
getAuxStream() - Method in class umontreal.iro.lecuyer.randvar.BetaStratifiedRejectionGen
Returns the auxiliary stream associated with this object.
getAuxStream() - Method in class umontreal.iro.lecuyer.randvar.GammaAcceptanceRejectionGen
Returns the auxiliary stream associated with this object.
getAuxStream() - Method in class umontreal.iro.lecuyer.randvar.GammaRejectionLoglogisticGen
Returns the auxiliary stream associated with this object.
getAuxStream() - Method in class umontreal.iro.lecuyer.randvar.UnuranContinuous
Returns the auxiliary random number stream.
getAuxStream() - Method in class umontreal.iro.lecuyer.randvar.UnuranDiscreteInt
Returns the auxiliary random number stream.
getAuxStream() - Method in class umontreal.iro.lecuyer.randvar.UnuranEmpirical
Returns the auxiliary random number stream.
getAv() - Method in class jhplot.stat.FactorialMoments
Return average multiplicity as a function of bin
getAvailable() - Method in class umontreal.iro.lecuyer.simprocs.Bin
Returns the number of available tokens for this bin.
getAvailable() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Returns the number of available units, i.e., the capacity minus the number of units busy.
getAvailableLocales() - Static method in class org.apache.commons.math.complex.ComplexFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math.fraction.BigFractionFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math.fraction.FractionFormat
Get the set of locales for which complex formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math.geometry.Vector3DFormat
Get the set of locales for which 3D vectors formats are available.
getAvailableLocales() - Static method in class org.apache.commons.math.linear.RealVectorFormat
Get the set of locales for which real vectors formats are available.
getAverageCLs() - Method in class jhpro.stat.ConfidenceLevel
Get average CLs.
getAverageCLsb() - Method in class jhpro.stat.ConfidenceLevel
Get average CLsb.
getAxesArrow(int) - Method in class jhplot.jadraw.JaAxes
Is arrow to be shown
getAxesColor() - Method in class jhplot.HPlot
Returns the actual color of the axes of the graph.
getAxesFontColor() - Method in class jhplot.HPlot3D
Color for tic labels
getAxesRatio() - Method in class jhplot.HPlot
Returns the current ratio between X- and Y-axes lengths.
getAxesRatioUse() - Method in class jhplot.HPlot
Says whether we should use a fixed ratio between X- and Y-axes lengths.
getAxis() - Method in class jhplot.H1D
Get histogram Axis class.
getAxis(int) - Method in class jhplot.HPlot2D
Return axis objects
getAxis() - Method in class jhplot.HProf1D
Get histogram Axis class.
getAxis() - Method in class org.apache.commons.math.geometry.Rotation
Get the normalized axis of the rotation.
getAxisArrow() - Method in class jhplot.HPlot
Gets axis arrows.
getAxisFont() - Method in class jhplot.HPlot3D
Get font for axes
getAxisLabel(int) - Method in class jhplot.HPlotJa
Get axis labels for the current pad (navigated using cd() method).
getAxisPenTicWidth() - Method in class jhplot.HPlot
Get the pen width to draw tick axes
getAxisTitle(int) - Method in class jhplot.HPlot2D
Get label title
getAxisX() - Method in class jhplot.H2D
Get IAxis in X
getAxisX() - Method in class jhplot.HProf2D
Get IAxis in X
getAxisY() - Method in class jhplot.H2D
Get IAxis in Y
getAxisY() - Method in class jhplot.HProf2D
Get IAxis in Y
getB() - Method in class org.apache.commons.math.optimization.fitting.GaussianFunction
Gets b parameter value.
getB() - Method in class umontreal.iro.lecuyer.functions.PowerMathFunction
Returns the value of b.
getB() - Method in class umontreal.iro.lecuyer.functions.SquareMathFunction
Returns the value of b.
getB() - Method in class umontreal.iro.lecuyer.probdist.BetaDist
Returns the parameter b of this object.
getB() - Method in class umontreal.iro.lecuyer.probdist.PowerDist
Returns the parameter b.
getB() - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
Returns the value of b for this object.
getB() - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Returns the value of b.
getB() - Method in class umontreal.iro.lecuyer.probdist.UniformDist
Returns the parameter b.
getB() - Method in class umontreal.iro.lecuyer.randvar.BetaGen
Returns the parameter b of this object.
getB() - Method in class umontreal.iro.lecuyer.randvar.PowerGen
Returns the parameter b.
getB() - Method in class umontreal.iro.lecuyer.randvar.TriangularGen
Returns the value of b for this object.
getB() - Method in class umontreal.iro.lecuyer.randvar.UniformGen
Returns the value of b for this object.
getB() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
Returns the value of b.
getB() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
Returns the value of b.
getB() - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Returns the value of b.
getBack() - Method in class jhplot.jadraw.JaLineObject
Returns the back property of this line object.
getBack() - Method in class jhpro.stat.limit.ExpData
Get the expected background
getBackgColor() - Method in class jhplot.HPlot
Returns the actual background color of the entire graph panel.
getBackgColorGraph() - Method in class jhplot.HPlot
Returns the background color of the current graph.
getBackground() - Method in class jhpro.stat.DataSource
Get data for background
getBaseBandwidth(EmpiricalDist) - Static method in class umontreal.iro.lecuyer.randvar.KernelDensityGen
Computes and returns the value of h0 in.
getBaseColor() - Method in class jhplot.v3d.Pyramid
 
getBatchNumber() - Method in class jhplot.HCellular
Returns the batch number
getBestEstimates() - Method in class flanagan.analysis.Regression
 
getBestEstimatesErrors() - Method in class flanagan.analysis.Regression
 
getbestestimatesStandardDeviations() - Method in class flanagan.analysis.Regression
 
getBestEstimatesStandardDeviations() - Method in class flanagan.analysis.Regression
 
getBeta() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleQRDecomposition
Returns a copy of the beta factors, from the Householder reflections H = I - beta*v*v'.
getBeta() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatQRDecomposition
Returns a copy of the beta factors, from the Householder reflections H = I - beta*v*v'.
getBeta() - Method in class jhplot.bsom.Bsom
 
getBeta() - Method in class jhplot.HBsom
Get beta
getBeta() - Method in class jhplot.math.num.pdf.Beta
Access the beta parameter.
getBeta() - Method in class jhplot.math.num.pdf.Gamma
Access the beta parameter.
getBeta() - Method in interface org.apache.commons.math.distribution.BetaDistribution
Access the shape parameter, beta
getBeta() - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
Access the shape parameter, beta
getBeta() - Method in interface org.apache.commons.math.distribution.GammaDistribution
Access the scale parameter, beta
getBeta() - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Access the scale parameter, beta
getBeta() - Method in class umontreal.iro.lecuyer.probdist.BetaDist
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
Returns the value of β for this object.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Returns the β parameter of this object.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Returns the parameter β.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
Returns the parameter β.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Returns the β parameter of this object.
getBeta() - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Returns the β parameter of this object.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.BetaGen
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.CauchyGen
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.FatigueLifeGen
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.FrechetGen
Returns the parameter β.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.GumbelGen
Returns the parameter β.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.InverseGammaGen
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.LoglogisticGen
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.NormalInverseGaussianGen
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.ParetoGen
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.Pearson5Gen
Returns the parameter β of this object.
getBeta() - Method in class umontreal.iro.lecuyer.randvar.Pearson6Gen
Returns the β parameter of this object.
getBeta() - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Returns beta.
getBinCount() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Returns the number of bins.
getBinCount() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Returns the number of bins.
getBins() - Method in class jhplot.H1D
Get the number of bins
getBins() - Method in class jhplot.HProf1D
Get the number of bins
getBins(int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the bins for a series.
getBins(int) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Returns the bins for a series.
getBinSize() - Method in class jhplot.H1D
Get bin width in case of fixed-size bins.
getBinSize(int) - Method in class jhplot.H1D
Get bin width for index i
getBinSize() - Method in class jhplot.HProf1D
Get bin width in case of fixed-size bins.
getBinStats() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Returns a list of SummaryStatistics containing statistics describing the values in each of the bins.
getBinStats() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Returns a List of SummaryStatistics instances containing statistics describing the values in each of the bins.
getBinsX() - Method in class jhplot.H2D
Get the number of bins in X
getBinsX() - Method in class jhplot.HProf2D
Get the number of bins in X
getBinsY() - Method in class jhplot.H2D
Get the number of bins in Y
getBinsY() - Method in class jhplot.HProf2D
Get the number of bins in Y
getBinWidth() - Method in class jhplot.DrawOptions
get the bin width.
getBinWidth(int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the bin width for a series.
getBMPCA() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCA
Returns the BrownianMotionPCA that is included in the GammaProcessPCA object.
getBMPCA() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCABridge
Returns the inner BrownianMotionPCA.
getBool(int, int) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Returns the value of the bit in the specified row and column.
getBool(int) - Method in class umontreal.iro.lecuyer.util.BitVector
Gives the value of the bit in position pos.
getBoolean(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getBooleanProperty(int) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getBooleanWeightingOption() - Method in class flanagan.analysis.ProbabilityPlot
 
getBoundingBox() - Method in class jhplot.jadraw.JaLatexText
Returns the bounding box of this latex text object.
getBoundingBox() - Method in class jhplot.jadraw.JaObject
Returns the bounding box of this JaObject.
getBoundIsAllowed() - Method in exception org.apache.commons.math.exception.NumberIsTooLargeException
 
getBoundIsAllowed() - Method in exception org.apache.commons.math.exception.NumberIsTooSmallException
 
getBoxColor() - Method in class jhplot.HPlot
Returns the color used to draw the bounding box.
getBoxFillColor() - Method in class jhplot.HPlot
Returns the fill-color of the eventual bounding box arround the graph
getBoxOffset() - Method in class jhplot.HPlot
Returns the offset of the bounding box.
getBP(int) - Method in class jhplot.stat.BunchingParameters
Return results: BP as a function of number of bins.
getBrownianMotion() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
Returns a reference to the BrownianMotion object used to generate the process.
getBrownianMotion() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Returns a reference to the inner BrownianMotion.
getBrownianMotionPCA() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessPCA
Returns the BrownianMotionPCA.
getBuffer() - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Returns the StringBuffer associated with that object.
getBufferSize() - Method in class jhplot.io.HFile
Get current buffer size for I/O.
getBufferSize() - Method in class jhplot.io.HFileXML
Get current buffer size for I/O.
getBuildTime() - Static method in class cern.colt.Version
Returns the time this release was build; for example "Tue Apr 11 11:50:39 CEST 2000".
getBuildTime() - Static method in class jhplot.JHPlot
Get build date
getBuildVersion() - Static method in class cern.colt.Version
Returns the build version of this release.
getByte(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getByteProperty(int) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getC() - Method in class org.apache.commons.math.optimization.fitting.GaussianFunction
Gets c parameter value.
getC() - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Returns the shape parameter c of this object.
getC() - Method in class umontreal.iro.lecuyer.probdist.PowerDist
Returns the parameter c.
getC() - Method in class umontreal.iro.lecuyer.randvar.NakagamiGen
Returns the shape parameter c of this object.
getC() - Method in class umontreal.iro.lecuyer.randvar.PowerGen
Returns the parameter c.
getCachedGen() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Returns a reference to the random variate generator whose values are cached.
getCachedStream() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Returns a reference to the random stream whose values are cached.
getCachedValues() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Returns an array list containing the values cached by this random variate generator.
getCachedValues() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Returns an array list containing the values cached by this random stream.
getCacheIndex() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Return the index of the next cached value that will be returned by the generator.
getCacheIndex() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Return the index of the next cached value that will be returned by the stream.
getCAConfig() - Method in class jhplot.HCellular
Returns used CA space.
getCameraPosition() - Method in class jhplot.HPlot3DP
Get camera position.
getCandidates() - Method in class jhpro.stat.DataSource
Get data with candidates
getCanvas() - Method in class jhplot.HZirkel
Return the actual canvas where all objects are shown
getCanvas(String, int, int, int, int) - Static method in class jhplot.SHPlot
Create HPlot canvas with several plots.
getCanvas(String, int, int) - Static method in class jhplot.SHPlot
Construct a HPlot canvas with a single plot.
getCanvas(String) - Static method in class jhplot.SHPlot
Construct a HPlot canvas with a plot with the default size 600x400.
getCanvas() - Static method in class jhplot.SHPlot
Construct a HPlot canvas with a plot with the default size 600x400.
getCanvas(String, int, int, int, int) - Static method in class jhplot.SHPlot3D
Create HPlot3D canvas with several plots.
getCanvas(String, int, int) - Static method in class jhplot.SHPlot3D
Construct a HPlot3D canvas with a single plot.
getCanvas(String) - Static method in class jhplot.SHPlot3D
Construct a HPlot3D canvas with a plot with the default size 600x400.
getCanvas() - Static method in class jhplot.SHPlot3D
Construct a HPlot3D canvas with a plot with the default size 600x400.
getCanvas(String, int, int, int, int, boolean) - Static method in class jhplot.SHPlotJa
Create HPlotJa canvas with several plots.
getCanvas(String, int, int, int, int) - Static method in class jhplot.SHPlotJa
Create HPlot canvas with several plots.
getCanvas(String, int, int) - Static method in class jhplot.SHPlotJa
Construct a HPlot canvas with a single plot.
getCanvas(String) - Static method in class jhplot.SHPlotJa
Construct a HPlot canvas with a plot with the default size 600x400.
getCanvas() - Static method in class jhplot.SHPlotJa
Construct a HPlotJa canvas with a plot with the default size 600x400.
getCanvasPanel() - Method in class jhplot.GHPanel
get JPanel for the main panel which keeps the central panel and all 4 margins
getCapacity() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Returns the current capacity of the resource.
getCartesianArray() - Method in class hephysics.vec.SpacePoint
 
getCategory(int) - Method in class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
Returns the category-value in the specified series.
getCdf() - Method in class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Returns the chart of the cdf.
getCdX() - Method in class jhplot.GHFrame
Get location of the graph in the main canvas in X
getCdX() - Method in class jhplot.HPlotJa
Get location of the graph in the main canvas in X
getCdY() - Method in class jhplot.GHFrame
Get location of the graph on the main canvas in Y
getCdY() - Method in class jhplot.HPlotJa
Get location of the graph on the main canvas in Y
getCellSize() - Method in class jhplot.HCellular
Returns the cell size in dot
getCenter() - Method in class org.apache.commons.math.stat.clustering.Cluster
Get the point chosen to be the center of this cluster.
getCenters(int) - Method in class jhplot.stat.StatShape
Get the centers in non-quadrant method.
getCenters() - Method in class jminhep.cluster.Partition
Get cluster centers
getCenters() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of the centers array.
getCFmaxIter() - Static method in class flanagan.analysis.Regression
 
getCFmaxIter() - Static method in class flanagan.analysis.Stat
 
getCFtolerance() - Static method in class flanagan.analysis.Regression
 
getCFtolerance() - Static method in class flanagan.analysis.Stat
 
getChar(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getCharge() - Method in class hephysics.particle.LParticle
Get charge
getChargeParity() - Method in class hephysics.particle.HEParticle
Returns C charge conjugation parity
getCharProperty(int) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getChart() - Method in class jhplot.HChart
Returns current Chart
getChartMargin() - Method in class umontreal.iro.lecuyer.charts.XYChart
Returns the chart margin, which is the fraction by which the chart is enlarged on its borders.
getChartPanel() - Method in class jhplot.HChart
Returns current Chart panel
getChi2() - Method in class jhplot.stat.LinRegWeighted
Get chi2
getChi2() - Method in class jhplot.stat.StatShape
Get Chi2 of this fit
getChiSquare() - Method in class flanagan.analysis.Regression
 
getchiSquare() - Method in class flanagan.analysis.Regression
 
getChiSquare(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Deprecated. Get the Chi-Square value.
getChiSquare() - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Get a Chi-Square-like value assuming the N residuals follow N distinct normal distributions centered on 0 and whose variances are the reciprocal of the weights.
getChiSquareProb() - Method in class flanagan.analysis.Regression
 
getchiSquareProb() - Method in class flanagan.analysis.Regression
 
getChiSquareTest() - Static method in class org.apache.commons.math.stat.inference.TestUtils
Deprecated. 2.2 will be removed in 3.0
getCholeskyDecompSigma() - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalCholeskyGen
Returns the lower-triangular matrix A in the Cholesky decomposition of Σ.
getChromosomes() - Method in class org.apache.commons.math.genetics.ListPopulation
Access the list of chromosomes.
getClassFinder() - Method in exception umontreal.iro.lecuyer.util.NameConflictException
Returns the class finder associated with this exception.
getCLb() - Method in class jhpro.stat.ConfidenceLevel
Get the Confidence Level for the background only.
getCLb(boolean) - Method in class jhpro.stat.ConfidenceLevel
Get the Confidence Level for the background only.
getCLs() - Method in class jhpro.stat.ConfidenceLevel
Get the Confidence Level defined by CLs = CLsb/CLb.
getCLs(boolean) - Method in class jhpro.stat.ConfidenceLevel
Get the Confidence Level defined by CLs = CLsb/CLb.
getCLsb() - Method in class jhpro.stat.ConfidenceLevel
Get the Confidence Level for the signal plus background hypothesis The confidence level for excluding the possibility of simultaneous presence of new particle production and background (the s + b hypothesis)
getCLsb(boolean) - Method in class jhpro.stat.ConfidenceLevel
Get the Confidence Level for the signal plus background hypothesis
getClusterNumber() - Method in class jminhep.cluster.DataPoint
Returns the cluster to which the data point belongs
getCoeff() - Method in class flanagan.analysis.Regression
 
getCoefficient(int) - Method in class umontreal.iro.lecuyer.functions.Polynomial
Returns the ith coefficient of the polynomial.
getCoefficients() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of the coefficients array.
getCoefficients() - Method in class org.apache.commons.math.optimization.linear.LinearConstraint
Get the coefficients of the constraint (left hand side).
getCoefficients() - Method in class org.apache.commons.math.optimization.linear.LinearObjectiveFunction
Get the coefficients of the linear equation being optimized.
getCoefficients(double[], double[], int) - Static method in class umontreal.iro.lecuyer.functionfit.LeastSquares
Computes and returns the coefficients of the fitting polynomial of degree degree.
getCoefficients(double[], double[]) - Static method in class umontreal.iro.lecuyer.functionfit.PolInterp
Computes and returns the coefficients the polynomial interpolating through the given points (x[0], y[0]), ..., (x[n], y[n]).
getCoefficients() - Method in class umontreal.iro.lecuyer.functions.Polynomial
Returns an array containing the coefficients of the polynomial.
getCoeffSd() - Method in class flanagan.analysis.Regression
 
getCoeffVar() - Method in class flanagan.analysis.Regression
 
getColor() - Method in class jhplot.DrawOptions
Return color used for points/lines
getColor() - Method in class jhplot.HKey
Get color of a label.
getColor() - Method in class jhplot.HLabel
Get color of a label.
getColor() - Method in class jhplot.HLabelEq
Get color of the label.
getColor() - Method in class jhplot.HMLabel
Get color of the label.
getColor() - Method in class jhplot.jadraw.JaObject
Returns the color of this object.
getColor() - Method in class jhplot.shapes.HShape
Get a color of the primitive
getColor(int) - Method in class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
Gets the current plotting color of the selected series.
getColor(int) - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Gets the current plotting color of the selected series.
getColorBack() - Method in class jhplot.v3d.Canvas3d
 
getColorBackground() - Method in class jhplot.HLabelEq
Get color of background.
getColorBar() - Method in class jhplot.HPlot2D
Get color bar (key) for the current plot
getColorMode() - Method in class jhplot.HPlot3D
Get current the color mode
getColors() - Method in class jhplot.SPlot
Get the point colors.
getColumn(int) - Method in class jhplot.PND
Return a specific column as an array
getColumn(int) - Method in class jhplot.PNI
Return a specific column as an array
getColumn(int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the entries in column number col as an array.
getColumn(int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the entries in column number col as an array.
getColumn(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the entries in column number col as an array.
getColumn(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the entries in column number col as an array.
getColumn(int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the entries in column number col as an array.
getColumn(int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the entries in column number col as an array.
getColumn(int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the entries in column number col as an array.
getColumn(int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entries in column number col as an array.
getColumnAsDoubleArray(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the entries in column number col as an array of double values.
getColumnAsDoubleArray(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the entries in column number col as an array of double values.
getColumnCompressed() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed(boolean) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed(boolean) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed(boolean) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed(boolean) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed(boolean) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressed() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed form.
getColumnCompressedModified() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed modified form.
getColumnCompressedModified() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed modified form.
getColumnCompressedModified() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed modified form.
getColumnCompressedModified() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed modified form.
getColumnCompressedModified() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a column-compressed modified form.
getColumnCopy(int) - Method in class flanagan.math.Matrix
 
getColumnCopy(double[][], int) - Static method in class jhplot.math.DoubleArray
Extract one column from a matrix.
getColumnCopy(double[][][], int, int) - Static method in class jhplot.math.DoubleArray
Extract one column from a three dimensional array.
getColumnCopy(int[][], int) - Static method in class jhplot.math.IntegerArray
 
getColumnCopy(int[][][], int, int) - Static method in class jhplot.math.IntegerArray
 
getColumnDimension(double[][], int) - Static method in class jhplot.math.DoubleArray
Get the number of columns in a specified row of a matrix.
getColumnDimension(int[][], int) - Static method in class jhplot.math.IntegerArray
 
getColumnDimension() - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in interface org.apache.commons.math.linear.AnyMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Returns the number of columns in the matrix.
getColumnDimension() - Method in class org.apache.commons.math.linear.SparseFieldMatrix
Returns the number of columns in the matrix.
getColumnIndexes() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Returns column indexes
getColumnIndexes() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Returns column indexes
getColumnIndexes() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Returns column indexes
getColumnIndexes() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Returns column indexes
getColumnIndexes() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Returns column indexes
getColumnIndexes() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Returns column indexes
getColumnIndexes() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Returns column indexes
getColumnMajor() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Returns a new matrix that has the same elements as this matrix, but they are addressed internally in column major.
getColumnMajor() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Returns a new matrix that has the same elements as this matrix, but they are addressed internally in column major.
getColumnMapping() - Method in class jhplot.io.csv.bean.ColumnPositionMappingStrategy
 
getColumnMapping() - Method in class jhplot.io.csv.bean.HeaderColumnNameTranslateMappingStrategy
 
getColumnMatrix(int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the entries in column number column as a column matrix.
getColumnMatrix(int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entries in column number column as a column matrix.
getColumnPointers() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Returns column pointers
getColumnPointers() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Returns column pointers
getColumnPointers() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Returns column pointers
getColumnPointers() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Returns column pointers
getColumnPointers() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Returns column pointers
getColumnPointers() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Returns column pointers
getColumnPointers() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Returns column pointers
getColumnsCopy(double[][], int...) - Static method in class jhplot.math.DoubleArray
Extract specific columns from a matrix.
getColumnsCopy(int[][], int...) - Static method in class jhplot.math.IntegerArray
 
getColumnsRangeCopy(double[][], int, int) - Static method in class jhplot.math.DoubleArray
Extract a range of columns from a matrix.
getColumnsRangeCopy(int[][], int, int) - Static method in class jhplot.math.IntegerArray
 
getColumnVector(int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the entries in column number column as a vector.
getColumnVector(int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entries in column number column as a vector.
getCompactness() - Method in class jminhep.cluster.Partition
Get compactness of the cluster configurations
getComplexInputData() - Method in class flanagan.math.FourierTransform
 
getComputerTime() - Method in class flanagan.math.TimeAndDate
 
getConditionNumber() - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Return the condition number of the matrix.
getConditionNumber() - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Return the condition number of the matrix.
getConfidence() - Method in class jhplot.stat.LinReg
Get confidence intervals for means
getConfidence(Color) - Method in class jhplot.stat.LinReg
Get confidence intervals for means
getConfidenceBand(Color, double) - Method in class jhplot.stat.LinReg
Calculate confidence band in form of P1D with errors.
getConfidenceBand(int, Color, double) - Method in class jhplot.stat.LinReg
Calculate confidence band in form of P1D with errors.
getConfidenceLevel() - Method in class umontreal.iro.lecuyer.stat.Tally
Returns the level of confidence for the intervals on the mean displayed in reports.
getConjugateTranspose() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns a new matrix that is a complex conjugate of this matrix.
getConjugateTranspose() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
getConjugateTranspose() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
getConjugateTranspose() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
getConjugateTranspose() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
getConjugateTranspose() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns a new matrix that is a complex conjugate of this matrix.
getConjugateTranspose() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
getConjugateTranspose() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
getConjugateTranspose() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
getConjugateTranspose() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
getConstantTerm() - Method in class org.apache.commons.math.optimization.linear.LinearObjectiveFunction
Get the constant of the linear equation being optimized.
getConstruction() - Method in class jhplot.HZirkel
Get construction to draw the objects
getContents() - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
Returns the contents of this histogram.
getContents() - Method in class hep.aida.tfloat.ref.FloatHistogram1D
Returns the contents of this histogram.
getContinuousDistribution(String) - Static method in class umontreal.iro.lecuyer.probdist.DistributionFactory
Uses the Java Reflection API to construct a ContinuousDistribution object by executing the code contained in the string str.
getContinuousVariables() - Method in class umontreal.iro.lecuyer.simevents.ContinuousState
Returns the list of continuous-time variables currently integrated by the simulator.
getContourBinsX() - Method in class jhplot.HPlotJa
Number of contour bins in X
getContourBinsY() - Method in class jhplot.HPlotJa
Number of contour bins in Y
getContourBinX() - Method in class jhplot.jadraw.JaAxes
Get number of bins in X for contour plot
getContourBinY() - Method in class jhplot.jadraw.JaAxes
Get number of bins in Y for contour plot
getContourLevels() - Method in class jhplot.HPlotJa
Number of contour levels
getContourLevels() - Method in class jhplot.jadraw.JaAxes
Get the number of levels to show contour plot
getContractionCriteria() - Method in class org.apache.commons.math.util.ResizableDoubleArray
The contraction criteria defines when the internal array will contract to store only the number of elements in the element array.
getConvergence() - Method in class org.apache.commons.math.ode.events.EventState
Get the convergence threshold for event localization.
getConvergenceChecker() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
Get the convergence checker.
getConvergenceChecker() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Get the convergence checker.
getConvergenceChecker() - Method in class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Get the convergence checker.
getConvergenceChecker() - Method in interface org.apache.commons.math.optimization.MultivariateRealOptimizer
Get the convergence checker.
getConvStatus() - Method in class flanagan.math.Maximisation
 
getConvStatus() - Method in class flanagan.math.Minimisation
 
getCoordinate(int, int) - Method in class jhplot.stat.PCA
Positions of the last coordinates of the projection vectors (eigenvectors)
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.AntitheticPointSet
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.BakerTransformedPointSet
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.CachedPointSet
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.ContainerPointSet
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.HaltonSequence
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.HammersleyPointSet
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.KorobovLatticeSequence
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.PaddedPointSet
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.PointSet
Returns ui, j, the coordinate j of the point i.
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.Rank1Lattice
 
getCoordinate(int, int) - Method in class umontreal.iro.lecuyer.hups.SubsetOfPointSet
 
getCoordinateNoGray(int, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Returns ui, j, the coordinate j of point i, the points being enumerated in the standard order (no Gray code).
getCoordinateNoGray(int, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
getCopy(double[], int...) - Static method in class jhplot.math.DoubleArray
Extract specific elements from an array.
getCopy(int[], int...) - Static method in class jhplot.math.IntegerArray
 
getCopy() - Method in class jhplot.P3D
get a copy of the current holder
getCorrCoeffMatrix() - Method in class flanagan.analysis.Regression
 
getCorrelation() - Method in class flanagan.math.FourierTransform
 
getCorrelation() - Method in class jhplot.stat.LinReg
Get correlation coefficient
getCorrelation() - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
 
getCorrelation(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Return the correlation matrix of the binormal distribution.
getCorrelation() - Method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
 
getCorrelation(int, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
Returns the correlation matrix of the bivariate Student's t distribution.
getCorrelation() - Method in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistributionMulti
Returns the correlation matrix of the distribution, defined as ρij = σij/(σ_iiσ_jj)1/2.
getCorrelation() - Method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
 
getCorrelation(double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
Computes the correlation matrix of the Dirichlet distribution with parameters (α1,...,αd).
getCorrelation() - Method in class umontreal.iro.lecuyer.probdistmulti.DiscreteDistributionIntMulti
Returns the correlation matrix of the distribution, defined as ρij = σij/(σ_iiσ_jj)1/2.
getCorrelation() - Method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
 
getCorrelation(int, double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Computes the correlation matrix of the multinomial distribution with parameters n and (p1,...,pd).
getCorrelation() - Method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
 
getCorrelation(double[], double[][]) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Computes the correlation matrix of the multinormal distribution with parameters μ and Σ).
getCorrelation() - Method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
 
getCorrelation(double, double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Computes the correlation matrix of the negative multinomial distribution with parameters γ and (p1,...,pd).
getCorrelationMatrix() - Method in class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Returns the correlation matrix
getCorrelationMatrix() - Method in class org.apache.commons.math.stat.correlation.SpearmansCorrelation
Calculate the Spearman Rank Correlation Matrix.
getCorrelationPValues() - Method in class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Returns a matrix of p-values associated with the (two-sided) null hypothesis that the corresponding correlation coefficient is zero.
getCorrelationStandardErrors() - Method in class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Returns a matrix of standard errors associated with the estimates in the correlation matrix.
getCorrelationStandardErrors().getEntry(i,j) is the standard error associated with getCorrelationMatrix.getEntry(i,j)
getCostEvaluations() - Method in class org.apache.commons.math.estimation.AbstractEstimator
Deprecated. Get the number of cost evaluations.
getCount(Object) - Method in class org.apache.commons.math.stat.Frequency
Deprecated. replaced by Frequency.getCount(Comparable) as of 2.0
getCount(Comparable<?>) - Method in class org.apache.commons.math.stat.Frequency
Returns the number of values = v.
getCount(int) - Method in class org.apache.commons.math.stat.Frequency
Returns the number of values = v.
getCount(long) - Method in class org.apache.commons.math.stat.Frequency
Returns the number of values = v.
getCount(char) - Method in class org.apache.commons.math.stat.Frequency
Returns the number of values = v.
getCount(int...) - Method in class org.apache.commons.math.util.MultidimensionalCounter
Convert to unidimensional counter.
getCount() - Method in class org.apache.commons.math.util.MultidimensionalCounter.Iterator
Get the current unidimensional counter slot.
getCount(int) - Method in class org.apache.commons.math.util.MultidimensionalCounter.Iterator
Get the current count in the selected dimension.
getCounts(int) - Method in class org.apache.commons.math.util.MultidimensionalCounter
Convert to multidimensional counter.
getCounts() - Method in class org.apache.commons.math.util.MultidimensionalCounter.Iterator
Get the current multidimensional counter slots.
getCovariance() - Method in class jhplot.stat.PCA
Get covariance matrix
getCovariance() - Method in class jhplot.stat.StatShape
Get covariance matrix.
getCovariance(double) - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Returns the n × n covariance matrix.
getCovariance(double) - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Returns the n × n covariance matrix.
getCovariance() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the covariance matrix of the values that have been added.
getCovariance() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns the covariance of the available values.
getCovariance() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the covariance matrix of the values that have been added.
getCovariance() - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
 
getCovariance(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Return the covariance matrix of the binormal distribution.
getCovariance() - Method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
 
getCovariance(int, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
Returns the covariance matrix of the bivariate Student's t distribution.
getCovariance() - Method in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistributionMulti
Returns the variance-covariance matrix of the distribution, defined as
σij = E[(Xi - μi)(Xj - μj)].
getCovariance() - Method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
 
getCovariance(double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
Computes the covariance matrix of the Dirichlet distribution with parameters (α1,...,αd).
getCovariance() - Method in class umontreal.iro.lecuyer.probdistmulti.DiscreteDistributionIntMulti
Returns the variance-covariance matrix of the distribution, defined as
σij = E[(Xi - μi)(Xj - μj)].
getCovariance() - Method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
 
getCovariance(int, double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Computes the covariance matrix of the multinomial distribution with parameters n and (p1,...,pd).
getCovariance() - Method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
 
getCovariance(double[], double[][]) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Computes the covariance matrix of the multinormal distribution with parameters μ and Σ.
getCovariance() - Method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
 
getCovariance(double, double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Computes the covariance matrix of the negative multinomial distribution with parameters γ and (p1,...,pd).
getCovarianceMatrix() - Method in class org.apache.commons.math.stat.correlation.Covariance
Returns the covariance matrix
getCovariances(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Deprecated. Get the covariance matrix of unbound estimated parameters.
getCovariances(EstimationProblem) - Method in interface org.apache.commons.math.estimation.Estimator
Deprecated. Get the covariance matrix of estimated parameters.
getCovariances() - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Get the covariance matrix of optimized parameters.
getCovMatrix() - Method in class flanagan.analysis.Regression
 
getCreatedBy() - Static method in class jhplot.JHPlot
Get JAVA version used to create
getCrossoverPolicy() - Method in class org.apache.commons.math.genetics.GeneticAlgorithm
Returns the crossover policy.
getCrossoverRate() - Method in class jhplot.HCellular
Returns the crossover rate
getCrossoverRate() - Method in class org.apache.commons.math.genetics.GeneticAlgorithm
Returns the crossover rate.
getCumFreq(Object) - Method in class org.apache.commons.math.stat.Frequency
Deprecated. replaced by Frequency.getCumFreq(Comparable) as of 2.0
getCumFreq(Comparable<?>) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(int) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(long) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumFreq(char) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative frequency of values less than or equal to v.
getCumPct(Object) - Method in class org.apache.commons.math.stat.Frequency
Deprecated. replaced by Frequency.getCumPct(Comparable) as of 2.0
getCumPct(Comparable<?>) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumPct(int) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumPct(long) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCumPct(char) - Method in class org.apache.commons.math.stat.Frequency
Returns the cumulative percentage of values less than or equal to v (as a proportion between 0 and 1).
getCurCoordIndex() - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Returns the index j of the current coordinate.
getCurDir() - Static method in class jhplot.HPlotJa
Returns the current working directory.
getCurPointIndex() - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Returns the index i of the current point.
getCurrentObservation() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns the value of the last generated observation X(tj).
getCurrentObservationIndex() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns the value of the index j corresponding to the time tj of the last generated observation.
getCurrentSignedStepsize() - Method in class org.apache.commons.math.ode.AbstractIntegrator
Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Get the current signed value of the integration stepsize.
getCurrentSignedStepsize() - Method in interface org.apache.commons.math.ode.ODEIntegrator
Get the current signed value of the integration stepsize.
getCurrentStepStart() - Method in class org.apache.commons.math.ode.AbstractIntegrator
Get the current value of the step start time ti.
getCurrentStepStart() - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Get the current value of the step start time ti.
getCurrentStepStart() - Method in class org.apache.commons.math.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the current value of the step start time ti.
getCurrentStepStart() - Method in interface org.apache.commons.math.ode.ODEIntegrator
Get the current value of the step start time ti.
getCurrentTime() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Get the current grid point time.
getCurrentTime() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Get the current soft grid point time.
getCurrentTime() - Method in interface org.apache.commons.math.ode.sampling.StepInterpolator
Get the current grid point time.
getCurrentUpperBound() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
 
getD() - Method in class cern.colt.matrix.linalg.EigenvalueDecomposition
Returns the block diagonal eigenvalue matrix, D.
getD() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleEigenvalueDecomposition
Returns the block diagonal eigenvalue matrix, D.
getD() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatEigenvalueDecomposition
Returns the block diagonal eigenvalue matrix, D.
getD() - Method in class jhplot.stat.PCA
Get transpose
getD() - Method in interface org.apache.commons.math.linear.EigenDecomposition
Returns the block diagonal matrix D of the decomposition.
getD() - Method in class org.apache.commons.math.linear.EigenDecompositionImpl
Returns the block diagonal matrix D of the decomposition.
getD() - Method in class org.apache.commons.math.optimization.fitting.GaussianFunction
Gets d parameter value.
getDash() - Method in class jhplot.jadraw.JaArcObject
Returns the dash property of this arc object.
getDash() - Method in class jhplot.jadraw.JaLineObject
Returns the dash property of this line object.
getDash() - Method in class jhplot.jadraw.JaLoopObject
Returns the dash property of this loop object.
getDashPattern(int) - Method in class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Returns the dash pattern associated with the series-th data series.
getDashPattern(int) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Returns the dash pattern associated with the seriesth data series.
getData() - Method in class jhplot.HNeuralNet
Get data
getData() - Method in class jhplot.HPlot
Get the vector which keeps all the data
getData() - Method in class jhplot.HPlotJa
Get the vector which keeps all the data
getData() - Method in class jhplot.jadraw.JaAxes
Get the vector which keeps all the data
getData() - Method in class jhplot.security.MD5
Get data as stream
getData(int) - Method in class jhplot.SPlot
Get the data in the specified dataset.
getData() - Method in class jhplot.stat.StatShape
Get data back used for fitting (can be inverted in Y and Y for best results).
getData() - Method in class jhplot.VHolder
Return a Vector with the data (rows of the dimension obtained by calling dimen()).
getData() - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math.linear.AbstractRealVector
Returns vector entries as a double array.
getData() - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math.linear.ArrayFieldVector
Returns vector entries as a T array.
getData() - Method in class org.apache.commons.math.linear.ArrayRealVector
Returns vector entries as a double array.
getData() - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in interface org.apache.commons.math.linear.FieldVector
Returns vector entries as a T array.
getData() - Method in class org.apache.commons.math.linear.OpenMapRealVector
Returns vector entries as a double array.
getData() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns matrix entries as a two-dimensional array.
getData() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Returns matrix entries as a two-dimensional array.
getData() - Method in interface org.apache.commons.math.linear.RealVector
Returns vector entries as a double array.
getData() - Method in class org.apache.commons.math.linear.SparseFieldVector
Returns vector entries as a T array.
getData() - Method in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
Get a copy of the stored data array.
getDataArray() - Method in class jhplot.P1D
Return a DataArray container from JPlot
getDataArray() - Method in class jhplot.P2D
Return a DataArray2D container.
getDataArray() - Method in class jhplot.P3D
Return a DataArray3D container.
getDataAsDoubleArray() - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns matrix entries as a two-dimensional array.
getDataAsDoubleArray() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns matrix entries as a two-dimensional array.
getDataLength() - Method in class jhplot.io.RecordWriter
Returns the number of bytes in the data.
getDataLength() - Method in class jhplot.stat.LinReg
Get the size of the input data
getDataLength() - Method in class jhplot.stat.LinRegWeighted
Get the size of the input data
getdataOffset() - Method in class flanagan.analysis.ProbabilityPlot
 
getDataRef() - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Returns a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Returns a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math.linear.ArrayFieldVector
Returns a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math.linear.ArrayRealVector
Returns a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns a reference to the underlying data array.
getDataRef() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Returns a reference to the underlying data array.
getDataSize() - Method in class jhpro.stat.limit.StatConfidence
Get number of experiments
getDataX() - Method in class jhplot.stat.LinReg
Get an array with X data
getDataX() - Method in class jhplot.stat.LinRegWeighted
Get an array with X data
getDataY() - Method in class jhplot.stat.LinReg
Get an array with Y data
getDataY() - Method in class jhplot.stat.LinRegWeighted
Get an array with Y data
getDate() - Method in class flanagan.math.TimeAndDate
 
getDayOfDate(int, String, int) - Method in class flanagan.math.TimeAndDate
 
getDayOfDate(int, int, int) - Method in class flanagan.math.TimeAndDate
 
getDayOfTheMonth() - Method in class flanagan.math.TimeAndDate
 
getDayOfTheWeek() - Method in class flanagan.math.TimeAndDate
 
getDayOfTheWeekAsInteger() - Method in class flanagan.math.TimeAndDate
 
getDefaultSimulator() - Static method in class umontreal.iro.lecuyer.simevents.Simulator
Returns the default simulator instance used by the deprecated class Sim.
getDegFree() - Method in class flanagan.analysis.Regression
 
getDegree() - Method in class umontreal.iro.lecuyer.functions.Polynomial
Returns the degree of this polynomial.
getDegreesOfFreedom() - Method in class jhplot.math.num.pdf.ChiSquared
Access the degrees of freedom.
getDegreesOfFreedom() - Method in class jhplot.math.num.pdf.TDistribution
Access the degrees of freedom.
getDegreesOfFreedom() - Method in interface org.apache.commons.math.distribution.ChiSquaredDistribution
Access the degrees of freedom.
getDegreesOfFreedom() - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Access the degrees of freedom.
getDegreesOfFreedom() - Method in interface org.apache.commons.math.distribution.TDistribution
Access the degrees of freedom.
getDegreesOfFreedom() - Method in class org.apache.commons.math.distribution.TDistributionImpl
Access the degrees of freedom.
getDelay() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
If the process is in the DELAYED state, returns the remaining time until the planned occurrence of its activating event.
getDelta() - Method in class flanagan.analysis.Regression
 
getDelta() - Method in class org.apache.commons.math.geometry.Vector3D
Get the elevation of the vector.
getDelta() - Method in class umontreal.iro.lecuyer.functions.ShiftedMathFunction
Returns the shift δ = delta.
getDelta() - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
Returns the parameter δ of this object.
getDelta() - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
Returns the parameter δ of this object.
getDelta() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Returns the value of δ for this object.
getDelta() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Returns the value of δ for this object.
getDelta() - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Returns the parameter δ of this object.
getDelta() - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
Returns the parameter δ.
getDelta() - Method in class umontreal.iro.lecuyer.randvar.FrechetGen
Returns the parameter δ.
getDelta() - Method in class umontreal.iro.lecuyer.randvar.GumbelGen
Returns the parameter δ.
getDelta() - Method in class umontreal.iro.lecuyer.randvar.JohnsonSBGen
Returns the δ associated with this object.
getDelta() - Method in class umontreal.iro.lecuyer.randvar.JohnsonSUGen
Returns the δ associated with this object.
getDelta() - Method in class umontreal.iro.lecuyer.randvar.NormalInverseGaussianGen
Returns the parameter δ of this object.
getDelta() - Method in class umontreal.iro.lecuyer.randvar.WeibullGen
Returns the parameter δ.
getDelta() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
Returns δ.
getDelta() - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Returns delta.
getDeltaT() - Method in class flanagan.math.FourierTransform
 
getDeltaTime() - Method in class jhplot.HCellular
Returns Delta time
getDenominator() - Method in class org.apache.commons.math.fraction.BigFraction
Access the denominator as a BigInteger.
getDenominator() - Method in class org.apache.commons.math.fraction.Fraction
Access the denominator.
getDenominatorAsInt() - Method in class org.apache.commons.math.fraction.BigFraction
Access the denominator as a int.
getDenominatorAsLong() - Method in class org.apache.commons.math.fraction.BigFraction
Access the denominator as a long.
getDenominatorDegreesOfFreedom() - Method in class jhplot.math.num.pdf.FDistribution
Access the denominator degrees of freedom.
getDenominatorDegreesOfFreedom() - Method in interface org.apache.commons.math.distribution.FDistribution
Access the denominator degrees of freedom.
getDenominatorDegreesOfFreedom() - Method in class org.apache.commons.math.distribution.FDistributionImpl
Access the denominator degrees of freedom.
getDenominatorFormat() - Method in class org.apache.commons.math.fraction.AbstractFormat
Access the denominator format.
getDense() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDense() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a dense form.
getDensity() - Method in class jhplot.H1D
Get a density distribution dividing each bin of the histogram by the bin width and the total number of heights for all bins.
getDensity() - Method in class jhplot.H2D
Get a density distribution dividing each bin of the histogram by the bin width and the total number of heights for all bins.
getDeriv() - Method in class flanagan.interpolation.BiCubicSpline
 
getDeriv() - Method in class flanagan.interpolation.CubicSpline
 
getDeriv() - Method in class flanagan.interpolation.PolyCubicSpline
 
getDeriv() - Method in class flanagan.interpolation.QuadriCubicSpline
 
getDeriv() - Method in class flanagan.interpolation.TriCubicSpline
 
getDerivative() - Method in class jhplot.math.num.root.NewtonRootFinder
Access the derivative of the target function.
getDeterminant() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Deprecated. 
getDeterminant() - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the determinant of this matrix.
getDeterminant() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the determinant of this matrix.
getDeterminant() - Method in interface org.apache.commons.math.linear.CholeskyDecomposition
Return the determinant of the matrix
getDeterminant() - Method in class org.apache.commons.math.linear.CholeskyDecompositionImpl
Return the determinant of the matrix
getDeterminant() - Method in interface org.apache.commons.math.linear.EigenDecomposition
Return the determinant of the matrix
getDeterminant() - Method in class org.apache.commons.math.linear.EigenDecompositionImpl
Return the determinant of the matrix
getDeterminant() - Method in interface org.apache.commons.math.linear.FieldLUDecomposition
Return the determinant of the matrix
getDeterminant() - Method in class org.apache.commons.math.linear.FieldLUDecompositionImpl
Return the determinant of the matrix
getDeterminant() - Method in interface org.apache.commons.math.linear.LUDecomposition
Return the determinant of the matrix
getDeterminant() - Method in class org.apache.commons.math.linear.LUDecompositionImpl
Return the determinant of the matrix
getDeterminant() - Method in interface org.apache.commons.math.linear.RealMatrix
Deprecated. as of release 2.0, replaced by new LUDecompositionImpl(m).getDeterminant()
getDeviancePart(double, double) - Static method in class jhplot.math.num.pdf.SaddlePoint
A part of the deviance portion of the saddle point approximation.
getDiagonal(double[][], int) - Static method in class jhplot.math.DoubleArray
Extract diagonal from a matrix.
getDimension(String) - Static method in class hep.aida.ref.function.PolynomialCoreNotNorm
 
getDimension() - Method in class jhplot.PND
Get last dimension of the data.
getDimension() - Method in class jhplot.PNI
Get last dimension of the data.
getDimension() - Method in class jminhep.cluster.DataPoint
Get dimension of the point
getDimension() - Method in exception org.apache.commons.math.exception.DimensionMismatchException
 
getDimension() - Method in class org.apache.commons.math.linear.ArrayFieldVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math.linear.ArrayRealVector
Returns the size of the vector.
getDimension() - Method in interface org.apache.commons.math.linear.FieldVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math.linear.OpenMapRealVector
Returns the size of the vector.
getDimension() - Method in interface org.apache.commons.math.linear.RealVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math.linear.SparseFieldVector
Returns the size of the vector.
getDimension() - Method in class org.apache.commons.math.ode.FirstOrderConverter
Get the dimension of the problem.
getDimension() - Method in interface org.apache.commons.math.ode.FirstOrderDifferentialEquations
Get the dimension of the problem.
getDimension() - Method in interface org.apache.commons.math.ode.SecondOrderDifferentialEquations
Get the dimension of the problem.
getDimension() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the dimension of the data
getDimension() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns the dimension of the data
getDimension() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the dimension of the data
getDimension() - Method in class org.apache.commons.math.util.MultidimensionalCounter
Get the number of dimensions of the multidimensional counter.
getDimension() - Method in class umontreal.iro.lecuyer.hups.ContainerPointSet
Returns the dimension of the contained point set.
getDimension() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet
 
getDimension() - Method in class umontreal.iro.lecuyer.hups.PointSet
Returns the dimension (number of available coordinates) of the point set.
getDimension() - Method in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistributionMulti
Returns the dimension d of the distribution.
getDimension() - Method in class umontreal.iro.lecuyer.probdistmulti.DiscreteDistributionIntMulti
Returns the dimension d of the distribution.
getDimension() - Method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Returns the dimension d of the distribution.
getDimension() - Method in class umontreal.iro.lecuyer.randvarmulti.RandomMultivariateGen
Returns the dimension of this multivariate generator (the dimension of the random points).
getDimension() - Method in interface umontreal.iro.lecuyer.util.MultivariateFunction
Returns d, the dimension of the function computed by this implementation.
getDimension() - Method in class umontreal.iro.lecuyer.util.RatioFunction
 
getDimension1() - Method in exception org.apache.commons.math.DimensionMismatchException
Deprecated. Get the first dimension
getDimension2() - Method in exception org.apache.commons.math.DimensionMismatchException
Deprecated. Get the second dimension
getDimention() - Method in class jminhep.cluster.DataHolder
Get the dimension of the data
getDirection() - Method in exception org.apache.commons.math.exception.NonMonotonousSequenceException
 
getDiscreteDistribution(String) - Static method in class umontreal.iro.lecuyer.probdist.DistributionFactory
Same as getContinuousDistribution, but for discrete distributions over the real numbers.
getDiscreteDistributionInt(String) - Static method in class umontreal.iro.lecuyer.probdist.DistributionFactory
Same as getContinuousDistribution, but for discrete distributions over the integers.
getDistance() - Method in class jhplot.HPlot3D
Get the distance
getDistance(RealVector) - Method in class org.apache.commons.math.linear.AbstractRealVector
Distance between two vectors.
getDistance(double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Distance between two vectors.
getDistance(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Distance between two vectors.
getDistance(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Distance between two vectors.
getDistance(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Distance between two vectors.
getDistance(OpenMapRealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Optimized method to compute distance.
getDistance(RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Distance between two vectors.
getDistance(double[]) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Distance between two vectors.
getDistance(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Distance between two vectors.
getDistance(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Distance between two vectors.
getDistribution(String) - Static method in class umontreal.iro.lecuyer.probdist.DistributionFactory
 
getDistribution() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGen
Returns the Distribution used by this generator.
getDistribution() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenInt
Returns the DiscreteDistributionInt used by this generator.
getDistribution() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
 
getDistribution() - Method in class umontreal.iro.lecuyer.randvar.UnuranContinuous
 
getDistribution() - Method in class umontreal.iro.lecuyer.randvar.UnuranDiscreteInt
 
getDistribution() - Method in class umontreal.iro.lecuyer.randvar.UnuranEmpirical
 
getDistributionMLE(String, double[], int) - Static method in class umontreal.iro.lecuyer.probdist.DistributionFactory
 
getDistributionMLE(String, int[], int) - Static method in class umontreal.iro.lecuyer.probdist.DistributionFactory
 
getDistributionMLE(Class<T>, double[], int) - Static method in class umontreal.iro.lecuyer.probdist.DistributionFactory
 
getDistributionMLE(Class<T>, int[], int) - Static method in class umontreal.iro.lecuyer.probdist.DistributionFactory
 
getDivergenceTolerance() - Method in class cern.colt.matrix.tdouble.algo.solver.DefaultDoubleIterationMonitor
Returns the relative divergence tolerance
getDivergenceTolerance() - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
Returns the relative divergence tolerance
getDivergenceTolerance() - Method in class cern.colt.matrix.tfloat.algo.solver.DefaultFloatIterationMonitor
Returns the relative divergence tolerance
getDivergenceTolerance() - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
Returns the relative divergence tolerance
getDivU() - Method in class jhplot.FPR
Get number of divisions for U
getDivV() - Method in class jhplot.FPR
Get number of divisions for V
getDLSeparation() - Method in class jhplot.jadraw.JaArcObject
Returns the double line separation of this object.
getDLSeparation() - Method in class jhplot.jadraw.JaLineObject
Returns the double line property.
getDLSeparation() - Method in class jhplot.jadraw.JaLoopObject
Returns the double line property.
getDomainBounds() - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Returns domain (x-coordinates) min and max values.
getDouble(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getDoubleArrayList() - Method in class jhplot.P0D
Get data in form of DoubleArrayList from cern.colt package
getDoubleArrayList() - Method in class umontreal.iro.lecuyer.stat.TallyStore
Returns the DoubleArrayList object that contains the observations for this probe.
getDoubleLine() - Method in class jhplot.jadraw.JaArcObject
Returns the double line property.
getDoubleLine() - Method in class jhplot.jadraw.JaLineObject
Returns the double line property.
getDoubleLine() - Method in class jhplot.jadraw.JaLoopObject
Returns the double line property.
getDoubleProperty(int) - Method in class hep.aida.ref.function.JELCompiledExpression.ValueProvider
 
getDoubleProperty(int) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getDrawOption() - Method in class jhplot.DrawOptions
Get the drawing attributes
getDrawOptions() - Method in class jhplot.DrawOptions
Get all drawing options in form of a string
getDuplicateAbscissa() - Method in exception org.apache.commons.math.DuplicateSampleAbscissaException
Get the duplicate abscissa.
getDX(int) - Method in class jhplot.P3D
Return a specific dX-value.
getDY(int) - Method in class jhplot.P3D
Return a specific dY-value.
getDZ(int) - Method in class jhplot.P3D
Return a specific dZ-value.
getE() - Method in class hephysics.vec.HepLorentzVector
Get energy (as e())
getE() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant e.
getEccentricity() - Method in class jhpro.stat.EEcentricity
Get eccentricity, defined as 1-VarianceMin / VarianceMax.
getEigenvalue(int) - Method in class jhplot.stat.PCA
Information about eigenvalues
getEigenValues() - Method in class flanagan.math.Matrix
 
getEigenvalueTot(int) - Method in class jhplot.stat.PCA
Express eigenvalues as percentage of total
getEigenVector() - Method in class flanagan.math.Matrix
 
getEigenvector(int) - Method in interface org.apache.commons.math.linear.EigenDecomposition
Returns a copy of the ith eigenvector of the original matrix.
getEigenvector(int) - Method in class org.apache.commons.math.linear.EigenDecompositionImpl
Returns a copy of the ith eigenvector of the original matrix.
getEigenVectorsAsColumns() - Method in class flanagan.math.Matrix
 
getEigenVectorsAsRows() - Method in class flanagan.math.Matrix
 
getElement(int, int) - Method in class flanagan.math.Matrix
 
getElement(int) - Method in class jminhep.cluster.DataHolder
Get array of elements at position n of the data holder
getElement(int) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the element at the specified index
getElement(int) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the element at the specified index
getElement(int) - Method in interface org.apache.commons.math.util.DoubleArray
Returns the element at the specified index.
getElement(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns the element at the specified index
getElement() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat.Node
Returns the element stored into this node.
getElementCopy(int, int) - Method in class flanagan.math.Matrix
 
getElementPointer(int, int) - Method in class flanagan.math.Matrix
 
getElements() - Method in interface org.apache.commons.math.util.DoubleArray
Returns a double[] array containing the elements of this DoubleArray.
getElements() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns a double array containing the elements of this ResizableArray.
getElevationAngle() - Method in class jhplot.HPlot3D
Get the angle
getEliteSize() - Method in class jhplot.HCellular
Returns the populationSize
getElitismRate() - Method in class org.apache.commons.math.genetics.ElitisticListPopulation
Access the elitism rate.
getEmpiricalDistribution() - Method in class org.apache.commons.math.random.ValueServer
Getter for property empiricalDistribution.
getEnd() - Method in class jhplot.jadraw.JaArcObject
Returns the end property of this line object.
getEnd() - Method in class jhplot.jadraw.JaLineObject
Returns the end property of this line object.
getEndLength() - Method in class jhplot.shapes.Arrow
Get length of the ends
getEndWidth() - Method in class jhplot.shapes.Arrow
Get widths of the ends
getEndX(int, int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the end value for a bin.
getEndY(int, int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the end y-value for a bin (which is the same as the y-value).
getEntries() - Method in class hep.aida.tdouble.ref.DoubleHistogram1DContents
 
getEntries() - Method in class hep.aida.tfloat.ref.FloatHistogram1DContents
 
getEntries() - Method in class jhplot.io.HFile
Return processed number of entries
getEntries() - Method in class jhplot.io.HFileXML
Get number of processed entries
getEntries() - Method in class jhplot.io.PFile
Return file entries (ID,name,size).
getEntropy() - Method in class jhplot.H1D
Returns the entropy of the histogram.
getEntropy() - Method in class jhplot.HProf1D
Returns the entropy of the histogram.
getEntry(int, int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Returns the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Returns the entry in the specified index.
getEntry(int) - Method in class org.apache.commons.math.linear.ArrayRealVector
Returns the entry in the specified index.
getEntry(int, int) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the entry in the specified row and column.
getEntry(int) - Method in interface org.apache.commons.math.linear.FieldVector
Returns the entry in the specified index.
getEntry(int, int) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Returns the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Returns the entry in the specified index.
getEntry(int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entry in the specified row and column.
getEntry(int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Returns the entry in the specified row and column.
getEntry(int) - Method in interface org.apache.commons.math.linear.RealVector
Returns the entry in the specified index.
getEntry(int, int) - Method in class org.apache.commons.math.linear.SparseFieldMatrix
Returns the entry in the specified row and column.
getEntry(int) - Method in class org.apache.commons.math.linear.SparseFieldVector
Returns the entry in the specified index.
getEntryAsDouble(int, int) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the entry in the specified row and column as a double.
getEntryAsDouble(int, int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the entry in the specified row and column as a double.
getEpochError() - Method in class jhplot.HNeuralNet
Returns errors for each epoch.
getEpsilon() - Method in class umontreal.iro.lecuyer.probdist.InverseDistFromDensity
Returns the u-resolution eps associated with this object.
getEpsilon() - Method in class umontreal.iro.lecuyer.randvar.InverseFromDensityGen
Returns the u-resolution eps associated with this object.
getErr() - Method in class jhplot.math.ValueErr
Get current error
getErrBack() - Method in class jhpro.stat.limit.ExpData
Get error on background
getErrFraction() - Method in class jhpro.stat.limit.ExpData
Get error on efficiency.
getError() - Method in class flanagan.analysis.ErrorProp
 
getError(int) - Method in class jhpro.stat.DataKeeper
Get error at index
getErrorNames() - Method in class jhpro.stat.DataSource
Get names of the errors
getErrorOnBackground() - Method in class jhpro.stat.DataSource
Get systematics on background for all channels
getErrorOnData() - Method in class jhpro.stat.DataSource
Get systematics on data for all channels
getErrorOnSignal() - Method in class jhpro.stat.DataSource
Get errors on signal on all channels
getErrors() - Method in class hep.aida.tdouble.ref.DoubleHistogram1DContents
 
getErrors() - Method in class hep.aida.tfloat.ref.FloatHistogram1DContents
 
getErrors() - Method in class jhpro.stat.DataKeeper
 
getErrors() - Method in class jhpro.stat.Moments
Get errors on the moment calculations
getErrors() - Method in class jhpro.stat.MomentsFac
Get errors on the moment calculations.
getErrors() - Method in class jhpro.stat.MomentsFacNorm
Get errors on the factorial moment calculations.
getErrors() - Method in class jhpro.stat.MomentsNorm
Get errors on the factorial moment calculations.
getESplit() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant e split in two pieces.
getEstimate() - Method in class org.apache.commons.math.estimation.EstimatedParameter
Deprecated. Get the current estimate of the parameter
getEta() - Method in class hephysics.vec.Hep3Vector
 
getEta() - Method in class hephysics.vec.HepLorentzVector
Get a pseudorapidity: eta=-ln (tan (theta/2)) )
getEvaluations() - Method in class org.apache.commons.math.ode.AbstractIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Get the number of evaluations of the differential equations function.
getEvaluations() - Method in interface org.apache.commons.math.ode.ODEIntegrator
Get the number of evaluations of the differential equations function.
getEvaluations() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in interface org.apache.commons.math.optimization.MultivariateRealOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
Get the number of evaluations of the objective function.
getEvaluations() - Method in class org.apache.commons.math.optimization.univariate.BracketFinder
 
getEvaluations() - Method in interface org.apache.commons.math.optimization.UnivariateRealOptimizer
Get the number of evaluations of the objective function.
getEventHandler() - Method in class org.apache.commons.math.ode.events.EventState
Get the underlying event handler.
getEventHandlers() - Method in class org.apache.commons.math.ode.AbstractIntegrator
Get all the event handlers that have been added to the integrator.
getEventHandlers() - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Get all the event handlers that have been added to the integrator.
getEventHandlers() - Method in interface org.apache.commons.math.ode.ODEIntegrator
Get all the event handlers that have been added to the integrator.
getEventList() - Static method in class umontreal.iro.lecuyer.simevents.Sim
Gets the currently used event list.
getEventList() - Method in class umontreal.iro.lecuyer.simevents.Simulator
Gets the currently used event list.
getEventsHandlers() - Method in class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Get all the events handlers that have been added to the manager.
getEventsStates() - Method in class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Get all the events state wrapping the handlers that have been added to the manager.
getEventTime() - Method in class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Get the occurrence time of the first event triggered in the last evaluated step.
getEventTime() - Method in class org.apache.commons.math.ode.events.EventState
Get the occurrence time of the event triggered in the current step.
getExpansionFactor() - Method in class org.apache.commons.math.util.ResizableDoubleArray
The expansion factor controls the size of a new array when an array needs to be expanded.
getExpansionMode() - Method in class org.apache.commons.math.util.ResizableDoubleArray
The expansionMode determines whether the internal storage array grows additively (ADDITIVE_MODE) or multiplicatively (MULTIPLICATIVE_MODE) when it is expanded.
getExpData() - Method in class jhpro.stat.limit.StatConfidence
Get experimental data
getExpectedCLb_b(int) - Method in class jhpro.stat.ConfidenceLevel
Get the expected Confidence Level for the background only if there is only background.
getExpectedCLb_b() - Method in class jhpro.stat.ConfidenceLevel
Get the expected Confidence Level for the background only if there is only background.These are indications of how well an experiment would do on average in excluding a signal if the signal truly is not present, and are the important figures of merit when optimizing an analysis for exclusion.
getExpectedCLb_sb(int) - Method in class jhpro.stat.ConfidenceLevel
Get the expected Confidence Level for the background only if there is signal and background.
getExpectedCLb_sb() - Method in class jhpro.stat.ConfidenceLevel
Get the expected Confidence Level for the background only if there is signal and background.
getExpectedCLs_b(int) - Method in class jhpro.stat.ConfidenceLevel
Get getExpectedCLsb_b/getExpectedCLb_b
getExpectedCLs_b() - Method in class jhpro.stat.ConfidenceLevel
Get getExpectedCLsb_b/getExpectedCLb_b.
getExpectedCLsb_b(int) - Method in class jhpro.stat.ConfidenceLevel
Get the expected Confidence Level for the signal plus background hypothesis if there is only background.
getExpectedCLsb_b() - Method in class jhpro.stat.ConfidenceLevel
Get the expected Confidence Level for the signal plus background hypothesis if there is only background.
getExpectedStatistic_b(int) - Method in class jhpro.stat.ConfidenceLevel
Get the expected statistic value in the background only hypothesis
getExpectedStatistic_b() - Method in class jhpro.stat.ConfidenceLevel
 
getExpectedStatistic_sb(int) - Method in class jhpro.stat.ConfidenceLevel
Get the expected statistic value in the signal plus background hypothesis
getExpForm() - Method in class jhplot.jadraw.JaAxes
Get exponential form
getExponent() - Method in interface org.apache.commons.math.distribution.ZipfDistribution
Get the exponent characterising the distribution.
getExponent() - Method in class org.apache.commons.math.distribution.ZipfDistributionImpl
Get the exponent characterising the distribution.
getExponent(double) - Static method in class org.apache.commons.math.util.FastMath
Return the exponent of a double number, removing the bias.
getExponent(float) - Static method in class org.apache.commons.math.util.FastMath
Return the exponent of a float number, removing the bias.
getEyePosition() - Method in class jhplot.HPlot3DP
Get a vector with eye position
getFa() - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Returns the value of F0(a).
getFaceColor(int) - Method in class jhplot.v3d.Pyramid
 
getFaurePermutation(int, int[]) - Static method in class umontreal.iro.lecuyer.hups.RadicalInverse
Computes the Faure permutation σb of the set {0,…, b - 1} and puts it in array pi.
getFb() - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Returns the value of F0(b).
getFD() - Method in class jhplot.math.io.LERandomAccessFile
 
getFft() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Returns new complex matrix which is the discrete Fourier transform (DFT) of this matrix.
getFft() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Returns new complex matrix which is the discrete Fourier transform (DFT) of this matrix.
getFft2() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of this matrix.
getFft2() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of this matrix.
getFft2() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of this matrix.
getFft2() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of this matrix.
getFft2() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of this matrix.
getFft2() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of this matrix.
getFft2() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of this matrix.
getFft2() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of this matrix.
getFft2Slices() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of each slice of this matrix.
getFft2Slices() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of each slice of this matrix.
getFft2Slices() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of each slice of this matrix.
getFft2Slices() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of each slice of this matrix.
getFft2Slices() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of each slice of this matrix.
getFft2Slices() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Returns new complex matrix which is the 2D discrete Fourier transform (DFT) of each slice of this matrix.
getFft3() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Returns new complex matrix which is the 3D discrete Fourier transform (DFT) of this matrix.
getFft3() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Returns new complex matrix which is the 3D discrete Fourier transform (DFT) of this matrix.
getFft3() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Returns new complex matrix which is the 3D discrete Fourier transform (DFT) of this matrix.
getFft3() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Returns new complex matrix which is the 3D discrete Fourier transform (DFT) of this matrix.
getFft3() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Returns new complex matrix which is the 3D discrete Fourier transform (DFT) of this matrix.
getFft3() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Returns new complex matrix which is the 3D discrete Fourier transform (DFT) of this matrix.
getFftColumns() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each column of this matrix.
getFftColumns() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each column of this matrix.
getFftColumns() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each column of this matrix.
getFftColumns() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each column of this matrix.
getFftColumns() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each column of this matrix.
getFftColumns() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each column of this matrix.
getFftColumns() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each column of this matrix.
getFftColumns() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each column of this matrix.
getFftRows() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each row of this matrix.
getFftRows() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each row of this matrix.
getFftRows() - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each row of this matrix.
getFftRows() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each row of this matrix.
getFftRows() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each row of this matrix.
getFftRows() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each row of this matrix.
getFftRows() - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each row of this matrix.
getFftRows() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Returns new complex matrix which is the discrete Fourier transform (DFT) of each row of this matrix.
getFHi() - Method in class org.apache.commons.math.optimization.univariate.BracketFinder
Get function value at BracketFinder.getHi().
getField() - Method in class org.apache.commons.math.complex.Complex
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math.dfp.Dfp
Get the Field (really a DfpField) to which the instance belongs.
getField() - Method in interface org.apache.commons.math.FieldElement
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math.fraction.BigFraction
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math.fraction.Fraction
Get the Field to which the instance belongs.
getField() - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Get the type of field elements of the matrix.
getField() - Method in class org.apache.commons.math.linear.ArrayFieldVector
Get the type of field elements of the vector.
getField() - Method in interface org.apache.commons.math.linear.FieldMatrix
Get the type of field elements of the matrix.
getField() - Method in interface org.apache.commons.math.linear.FieldVector
Get the type of field elements of the vector.
getField() - Method in class org.apache.commons.math.linear.SparseFieldVector
Get the type of field elements of the vector.
getField() - Method in class org.apache.commons.math.util.BigReal
Get the Field to which the instance belongs.
getField(Class<?>, String) - Static method in class umontreal.iro.lecuyer.util.Introspection
This is like getField, except that it can return non-public fields.
getFieldName(Object) - Static method in class umontreal.iro.lecuyer.util.Introspection
Returns the field name corresponding to the value of an enumerated type val.
getFields(Class<?>) - Static method in class umontreal.iro.lecuyer.util.Introspection
Returns all the fields declared and inherited by a class.
getFilePointer() - Method in class jhplot.math.io.LERandomAccessFile
 
getFill() - Method in class jhplot.shapes.HShape
Is this primitive filled?
getFillColor() - Method in class jhplot.FPR
Get color used to fill.
getFillColor() - Method in class jhplot.jadraw.JaFillObject
Returns the fill color of the fillColor object.
getFillColor() - Method in class jhplot.jadraw.JaVertexT2
Returns the fill color of the fillColor object.
getFilled(int) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Returns the filled flag associated with the series-th data series.
getFinalTime() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Get the final integration time.
getFirst() - Method in class org.apache.commons.math.genetics.ChromosomePair
Access the first chromosome.
getFirst() - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
getFirst() - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
getFirst() - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Returns the first event in the event list.
getFirst() - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
getFirst() - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
getFirst() - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
getFirst() - Method in class umontreal.iro.lecuyer.simevents.LinkedListStat
 
getFirstIndex() - Method in interface hep.aida.ref.tuple.FTupleEvent
 
getFirstIndex() - Method in class hep.aida.ref.tuple.TupleEvent
 
getFirstOfClass(String) - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
getFirstOfClass(Class<E>) - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
getFirstOfClass(String) - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
getFirstOfClass(Class<E>) - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
getFirstOfClass(String) - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Returns the first event of the class cl (a subclass of Event) in the event list.
getFirstOfClass(Class<E>) - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Returns the first event of the class E (a subclass of Event) in the event list.
getFirstOfClass(String) - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
getFirstOfClass(Class<E>) - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
getFirstOfClass(String) - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
getFirstOfClass(Class<E>) - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
getFirstOfClass(String) - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
getFirstOfClass(Class<E>) - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
getFitEngines() - Method in class jhplot.HFitter
Return available fit engines.
getFitFunction() - Method in class jhplot.stat.StatShape
Get a fit function after the linear regression (major axis).
getFitFunctionPerp() - Method in class jhplot.stat.StatShape
Get a fit function perpendicular to the linear regression line (minor axis).
getFitFunctionQuadrants() - Method in class jhplot.stat.StatShape
Get linear functions after rotation of major and minor axes by 45 deg to define the quadrants.
getFitMethod() - Method in class jhplot.HFitter
Return available fit methods.
getFitness() - Method in class org.apache.commons.math.genetics.Chromosome
Access the fitness of this chromosome.
getFitParameters() - Method in class jhplot.stat.StatShape
Get fit parameters, the intercept (0) and the slope (1)
getFitParametersPerp() - Method in class jhplot.stat.StatShape
Get fit parameters of a function perpendicular (minor) axis to the linear regression line the intercept (0) and the slope (1)
getFitParametersRotate() - Method in class jhplot.stat.StatShape
Parameters after rotation of major and minor axes by 45deg.
getFitPolynomialIndex(double) - Method in class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Returns the index of P, the Polynomial instance used to evaluate x, in an ArrayList table instance returned by getSplinePolynomials().
getFittedFunc() - Method in class jhplot.HFitter
Get results of the fit in form of function
getFitter() - Method in class jhplot.HFitter
Return Jaida fitter
getFittestChromosome() - Method in class org.apache.commons.math.genetics.ListPopulation
Access the fittest chromosome in this population.
getFittestChromosome() - Method in interface org.apache.commons.math.genetics.Population
Access the fittest chromosome in this population.
getFixedVars() - Method in class jhplot.FND
String with fixed variables
getFlags() - Method in class hep.aida.ref.event.TreeEvent
 
getFlip() - Method in class jhplot.jadraw.JaArcObject
Returns the flip property of this arc object.
getFlip() - Method in class jhplot.jadraw.JaLineObject
Returns the flip property of this line object.
getFlip() - Method in class jhplot.jadraw.JaLoopObject
Returns the flip property of this loop object.
getFloat(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getFloatProperty(int) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getFLow() - Method in class org.apache.commons.math.optimization.univariate.BracketFinder
Get function value at BracketFinder.getLo().
getFM(int) - Method in class jhplot.stat.FactorialMoments
Return factorial moments (without normalization): log(FM) as a function of number of bins.
getFMid() - Method in class org.apache.commons.math.optimization.univariate.BracketFinder
Get function value at BracketFinder.getMid().
getFont() - Method in class jhplot.HKey
Get the font of the label text.
getFont() - Method in class jhplot.HLabel
Get the font of the label text.
getFont() - Method in class jhplot.HMLabel
Get the text font.
getFont() - Method in class jhplot.jadraw.JaKey
Returns the textFont property of this text object.
getFont() - Method in class jhplot.jadraw.JaText
Returns the textFont property of this text object.
getFont() - Method in class jhplot.jadraw.JaTextBox
Returns the textFont property of this text object.
getFont() - Method in class jhplot.shapes.Text
Get the font
getFontSize() - Method in class jhplot.HLabelEq
Get the font size of the equation.
getFormat() - Method in class org.apache.commons.math.geometry.Vector3DFormat
Get the components format.
getFormat() - Method in class org.apache.commons.math.linear.RealVectorFormat
Get the components format.
getFov() - Method in class jhplot.HPlot3DP
Get field of vision
getFpmin() - Static method in class flanagan.analysis.Stat
 
getFraction() - Method in class jhpro.stat.limit.ExpData
Get efficiency.
getFrame() - Method in class jhplot.GHFrame
Get the main frame which keeps the components
getFrameColor() - Method in class jhplot.HPlot3D
Get color of the frame
getFreq() - Method in class jhplot.jadraw.JaArcObject
Returns the freq property of this arc object.
getFreq() - Method in class jhplot.jadraw.JaLineObject
Returns the freq property of this line object.
getFreq() - Method in class jhplot.jadraw.JaLoopObject
Returns the freq property of this loop object.
getFrobeniusNorm() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the Frobenius norm of the matrix.
getFrobeniusNorm() - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the Frobenius norm of the matrix.
getFrobeniusNorm() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the Frobenius norm of the matrix.
getFtestSignificance(double) - Method in class flanagan.analysis.Regression
 
getFullDate() - Method in class flanagan.math.TimeAndDate
 
getFullTime12() - Method in class flanagan.math.TimeAndDate
 
getFullTime24() - Method in class flanagan.math.TimeAndDate
 
getFunc() - Method in class jhplot.HFitter
Return function
getFuncCatalog() - Method in class jhplot.HFitter
Return list of available functions
getFunction() - Method in class jhplot.math.num.integration.AdaptiveIntegrator
Access the target function.
getFunction() - Method in class jhplot.math.num.integration.RombergIntegrator
Access the target function.
getFunction() - Method in class jhplot.math.num.integration.SimpsonsIntegrator
Access the target function.
getFunction() - Method in class jhplot.math.num.integration.TrapezoidalIntegrator
Access the target function.
getFunction() - Method in class jhplot.math.num.root.BisectionRootFinder
Access the target function.
getFunction() - Method in class jhplot.math.num.root.Bracket
Access the target function.
getFunction() - Method in class jhplot.math.num.root.BrentRootFinder
Access the target function.
getFunction() - Method in class jhplot.math.num.root.FalsePositionRootFinder
Access the target function.
getFunction() - Method in class jhplot.math.num.root.NewtonRootFinder
Access the target function.
getFunction() - Method in class jhplot.math.num.root.SecantRootFinder
Access the target function.
getFunction() - Method in class umontreal.iro.lecuyer.functions.PowerMathFunction
Returns the function f (x).
getFunction() - Method in class umontreal.iro.lecuyer.functions.ShiftedMathFunction
Returns the function f (x).
getFunction() - Method in class umontreal.iro.lecuyer.functions.SqrtMathFunction
Returns the function associated with this object.
getFunction() - Method in class umontreal.iro.lecuyer.functions.SquareMathFunction
Returns the function f (x).
getFunctionCatalog() - Static method in class hep.aida.ref.function.FunctionCatalog
 
getFunctionCatalog(String) - Static method in class hep.aida.ref.function.FunctionCatalog
 
getFunctionCreator() - Method in class hep.aida.ref.function.FunctionCatalog
 
getFunctions() - Method in class umontreal.iro.lecuyer.functions.AverageMathFunction
Returns the functions being averaged.
getFunctionValue() - Method in interface org.apache.commons.math.analysis.solvers.UnivariateRealSolver
Get the result of the last run of the solver.
getFunctionValue() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverImpl
Deprecated. Get the result of the last run of the solver.
getFunctionValue() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Get the result of the last run of the optimizer.
getFunctionValue() - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
Get the result of the last run of the optimizer.
getFunctionValue() - Method in interface org.apache.commons.math.optimization.UnivariateRealOptimizer
Get the result of the last run of the optimizer.
getFunctionValueAccuracy() - Method in interface org.apache.commons.math.analysis.solvers.UnivariateRealSolver
Get the actual function value accuracy.
getFunctionValueAccuracy() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverImpl
Deprecated. Get the actual function value accuracy.
getGamma() - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Returns the parameter γ of this object.
getGamma() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Returns the value of γ for this object.
getGamma() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Returns the value of γ for this object.
getGamma() - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Returns the parameter γ of this object.
getGamma() - Method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Returns the parameter γ of this object.
getGamma() - Method in class umontreal.iro.lecuyer.randvar.FatigueLifeGen
Returns the parameter γ of this object.
getGamma() - Method in class umontreal.iro.lecuyer.randvar.JohnsonSBGen
Returns the γ associated with this object.
getGamma() - Method in class umontreal.iro.lecuyer.randvar.JohnsonSUGen
Returns the γ associated with this object.
getGamma() - Method in class umontreal.iro.lecuyer.randvar.NegativeBinomialGen
Returns the parameter γ of this object.
getGamma() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
Returns γ.
getGamma() - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Returns gamma.
getGammaProcess() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Returns a reference to the inner GammaProcess.
getGBackground() - Method in class jhplot.GHMargin
Get the color of background
getGColor() - Method in class jhplot.GHMargin
Get the color of this panel
getGen() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Returns the normal random variate generator used.
getGen() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
Returns the noncentral chi-square random variate generator used.
getGen() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
Returns the normal random variate generator used.
getGen() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
Returns the NormalGen used.
getGen() - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Returns the normal random variate generator used.
getGen1() - Method in class umontreal.iro.lecuyer.randvarmulti.IIDMultivariateGen
Returns the common one-dimensional generator used in this class.
getGeneralPath() - Method in class jhplot.jadraw.JaObject
Returns the GeneralPath that draws this JaObject.
getGeneralPattern() - Method in exception org.apache.commons.math.exception.MathIllegalArgumentException
Gets the localizable pattern used to build the general part of the message of this throwable.
getGeneralPattern() - Method in exception org.apache.commons.math.exception.MathIllegalStateException
Gets the localizable pattern used to build the general part of the message of this throwable.
getGeneralPattern() - Method in interface org.apache.commons.math.exception.MathThrowable
Gets the localizable pattern used to build the general part of the message of this throwable.
getGeneralPattern() - Method in exception org.apache.commons.math.exception.MathUnsupportedOperationException
Gets the localizable pattern used to build the general part of the message of this throwable.
getGeneralPattern() - Method in exception org.apache.commons.math.MathException
Gets the localizable pattern used to build the general part of the message of this throwable.
getGeneralPattern() - Method in exception org.apache.commons.math.MathRuntimeException
Gets the localizable pattern used to build the general part of the message of this throwable.
getGenerationsEvolved() - Method in class org.apache.commons.math.genetics.GeneticAlgorithm
Returns the number of generations evolved to reach StoppingCondition in the last run.
getGenerator() - Method in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Get the underlying normalized components generator.
getGeneratorUpperBounds() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Returns a fresh copy of the array of upper bounds of the subintervals of [0,1] used in generating data from the empirical distribution.
getGeoMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured geometric mean implementation
getGeoMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured geometric mean implementation
getGeometricMean() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns the geometric mean of all the aggregated data.
getGeometricMean() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the geometric mean of the available values
getGeometricMean() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getGeometricMean() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that correspond to each multivariate sample
getGeometricMean() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the geometric mean of the values that have been added.
getGeometricMean() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the geometric mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getGeometricMean() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the geometric mean of the values that have been added.
getGeometricMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured geometric mean implementation.
getGFont() - Method in class jhplot.GHMargin
Get the font of the text
getGlobalCurrentTime() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Get the current global grid point time.
getGlobalPreviousTime() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Get the previous global grid point time.
getGneg() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
Returns a reference to the GammaProcess object gneg used to generate the Γ- component of the process.
getGoalOfHs() - Method in class jhplot.HCellular
Returns the crossover rate
getGoalType() - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
 
getGpos() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
Returns a reference to the GammaProcess object gpos used to generate the Γ+ component of the process.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaArcObject
Determines which handle the user has selected to move/resize/edit this arc.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaAxes
Determines where on this JaObject a mouse click has ocurred.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaBlob
Determines where on this JaObject a mouse click has ocurred.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaBox
Determines where on this JaObject a mouse click has ocurred.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaKey
Determines where on this JaObject a mouse click has ocurred.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaLatexText
Determines where on this JaObject a mouse click has ocurred.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaLineObject
Determines which handle the user has selected to move/resize/edit this line.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaLoopObject
Determines which handle the user has selected to move/resize/edit this loop.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaObject
Determines which handle the user has selected to move/resize/edit an object.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaText
Determines where on this JaObject a mouse click has ocurred.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaTextBox
Determines where on this JaObject a mouse click has ocurred.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaVertex
Determines which handle the user has selected to move/resize/edit this vertex.
getGrabbedHandle(int, int, int) - Method in class jhplot.jadraw.JaVertexT5
Determines which handle the user has selected to move/resize/edit this vertex.
getGrad() - Method in class flanagan.analysis.Regression
 
getGradientEvaluations() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
Get the number of evaluations of the objective function gradient.
getGradientEvaluations() - Method in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Get the number of evaluations of the objective function gradient.
getGradientEvaluations() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Get the number of evaluations of the objective function gradient.
getGraph() - Method in class jhplot.HGraph
Returns the current graph
getGraphLabel() - Method in class jhplot.HKey
Get a label with default attributes
getGraphLabel() - Method in class jhplot.HLabel
Get a label with default attributes
getGraphLabel() - Method in class jhplot.HMLabel
Get a label with default attributes
getGraphSettings(int, int) - Method in class jhplot.HPlot
Get graph settings
getGraphSettings() - Method in class jhplot.HPlot
Get graph settings for current plot
getGrid() - Method in class jhplot.SPlot
Return whether the grid is drawn.
getGridColor() - Method in class jhplot.HPlot
Sets the color of the overall grid.
getGridColor() - Method in class jhplot.jadraw.JaAxes
Get grid color (gray is default)
getGTitle() - Method in class jhplot.HPlotJa
Get global title
getGuessedAmplitude() - Method in class org.apache.commons.math.optimization.fitting.HarmonicCoefficientsGuesser
Get the guessed amplitude a.
getGuessedPhase() - Method in class org.apache.commons.math.optimization.fitting.HarmonicCoefficientsGuesser
Get the guessed phase φ.
getGuessedPulsation() - Method in class org.apache.commons.math.optimization.fitting.HarmonicCoefficientsGuesser
Get the guessed pulsation ω.
getH() - Method in class cern.colt.matrix.linalg.QRDecomposition
Returns the Householder vectors H.
getH() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatQRDecomposition
Returns the Householder vectors H.
getH() - Method in class jhplot.math.QRDecomposition
Return the Householder vectors
getH() - Method in interface org.apache.commons.math.linear.QRDecomposition
Returns the Householder reflector vectors.
getH() - Method in class org.apache.commons.math.linear.QRDecompositionImpl
Returns the Householder reflector vectors.
getH1D(int) - Method in class jhplot.HBook
Get H1D histogram from the index (key)
getH1D() - Method in class jhplot.HProf1D
Make H1D copy of the current histogram.
getH1D(String) - Method in class jhplot.HProf1D
Convert to H1D for graphical representation using default graphics attributes.
getH1D(String, String) - Method in class jhplot.HProf1D
Convert to H1D for graphical representation using default graphics attributes.
getH1D(String) - Method in class jhplot.io.FileRoot
Get H1D histogram associated with the key name.
getH1D(int) - Method in class jhplot.P0D
Return H1D histogram with P0D content.
getH1D(int, double, double) - Method in class jhplot.P0D
Return H1D histogram with P0D content.
getH1D(int) - Method in class jhplot.P0I
Return H1D histogram with P0I content.
getH1D(int, double, double) - Method in class jhplot.P0I
Return H1D histogram with P0I content.
getH1D(int, Integer, Integer) - Method in class jhplot.P0I
Return H1D histogram with P0I content.
getH1D(int, double, double) - Method in class jhplot.PND
Return H1D histogram with PND content.
getH1D(int, double, double, int) - Method in class jhplot.PND
Make a histogram from a column of PND.
getH1D(int) - Method in class jhplot.PND
Create histogram.
getH1D(int, double, double) - Method in class jhplot.PNI
Return H1D histogram with PND content.
getH1D(int) - Method in class jhplot.PNI
Create histogram.
getH1D(int, double, double, int) - Method in class jhplot.PNI
Make a histogram from a column of PND.
getH2D(int) - Method in class jhplot.HBook
Get H2D histogram from the index (key) ID
getH2D(String) - Method in class jhplot.HProf2D
Make H2D copy of the current histogram.
getH2D(String, String) - Method in class jhplot.HProf2D
Make H2D copy of the current histogram.
getH2D() - Method in class jhplot.HProf2D
Convert to H2D keeping the original title
getH2D(String) - Method in class jhplot.io.FileRoot
Get H2D histogram associated with the key name.
getHandles(double, double, double, double) - Method in class hep.aida.ref.function.ExponentialCoreNotNorm
 
getHandles(double, double, double, double) - Method in class hep.aida.ref.function.FunctionCore
 
getHandles(double, double, double, double) - Method in class hep.aida.ref.function.GaussianCoreNotNorm
 
getHandles(double, double, double, double) - Method in class hep.aida.ref.function.LorentzianCoreNotNorm
 
getHandles(double, double, double, double) - Method in class hep.aida.ref.function.MoyalCoreNotNorm
 
getHandles(double, double, double, double) - Method in class hep.aida.ref.function.PolynomialCoreNotNorm
 
getHeight() - Method in class jhplot.jadraw.JaObject
Returns the height of this object.
getHeights() - Method in class hep.aida.tdouble.ref.DoubleHistogram1DContents
 
getHeights() - Method in class hep.aida.tfloat.ref.FloatHistogram1DContents
 
getHessenbergMatrix() - Method in class flanagan.math.Matrix
 
getHi() - Method in exception org.apache.commons.math.exception.OutOfRangeException
 
getHi() - Method in class org.apache.commons.math.optimization.univariate.BracketFinder
 
getHight() - Method in class jhplot.v3d.Model3d
 
getHour12() - Method in class flanagan.math.TimeAndDate
 
getHour24() - Method in class flanagan.math.TimeAndDate
 
getHours() - Method in class umontreal.iro.lecuyer.util.AbstractChrono
Returns the CPU time in hours used by the program since the last call to init for this AbstractChrono.
getHours() - Method in enum umontreal.iro.lecuyer.util.TimeUnit
Returns this time unit represented in hours.
getHTMLUrl(String) - Method in class jhplot.GHFrame
Returns a HTML page which is found in a valid image URL.
getI() - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Returns the parameter i.
getI() - Method in class umontreal.iro.lecuyer.randvar.UniformIntGen
Returns the parameter i.
getID() - Method in class hep.aida.ref.event.TreeEvent
 
getIDataPointSet() - Method in class jhplot.P1D
Get IDataPointSet.
getIDataPointSet() - Method in class jhplot.PND
Get the data point set for JAIDA
getIDataPointSet() - Method in class jhplot.PNI
Get the data point set for JAIDA
getIEEEFlags() - Method in class org.apache.commons.math.dfp.DfpField
Get the IEEE 854 status flags.
getIfft(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Returns new complex matrix which is the inverse of the discrete Fourier (IDFT) transform of this matrix.
getIfft(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Returns new complex matrix which is the inverse of the discrete Fourier (IDFT) transform of this matrix.
getIfft2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft2(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft2(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
getIfft2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
getIfft2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
getIfft2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
getIfft2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
getIfft2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Returns new complex matrix which is the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
getIfft3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Returns new complex matrix which is the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Returns new complex matrix which is the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft3(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Returns new complex matrix which is the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Returns new complex matrix which is the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Returns new complex matrix which is the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfft3(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Returns new complex matrix which is the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
getIfftColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
getIfftColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
getIfftColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
getIfftColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
getIfftColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
getIfftColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
getIfftColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
getIfftColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
getIfftRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
getIfftRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
getIfftRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
getIfftRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
getIfftRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
getIfftRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
getIfftRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
getIfftRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Returns new complex matrix which is the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
getIFunction() - Method in class jhplot.F1D
Return AIDA function
getImage() - Method in class jhplot.HLabelEq
Return image of this equation
getImageFile(String) - Method in class jhplot.HLabelEq
Return image of this equation as a file.
getImagEigenvalue(int) - Method in interface org.apache.commons.math.linear.EigenDecomposition
Returns the imaginary part of the ith eigenvalue of the original matrix.
getImagEigenvalue(int) - Method in class org.apache.commons.math.linear.EigenDecompositionImpl
Returns the imaginary part of the ith eigenvalue of the original matrix.
getImagEigenvalues() - Method in class cern.colt.matrix.linalg.EigenvalueDecomposition
Returns the imaginary parts of the eigenvalues.
getImagEigenvalues() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleEigenvalueDecomposition
Returns the imaginary parts of the eigenvalues.
getImagEigenvalues() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatEigenvalueDecomposition
Returns the imaginary parts of the eigenvalues.
getImagEigenvalues() - Method in interface org.apache.commons.math.linear.EigenDecomposition
Returns a copy of the imaginary parts of the eigenvalues of the original matrix.
getImagEigenvalues() - Method in class org.apache.commons.math.linear.EigenDecompositionImpl
Returns a copy of the imaginary parts of the eigenvalues of the original matrix.
getImaginary() - Method in class org.apache.commons.math.complex.Complex
Access the imaginary part.
getImaginaryCharacter() - Method in class org.apache.commons.math.complex.ComplexFormat
Access the imaginaryCharacter.
getImaginaryFormat() - Method in class org.apache.commons.math.complex.ComplexFormat
Access the imaginaryFormat.
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns the imaginary part of this matrix
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns the imaginary part of this matrix
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns the imaginary part of this matrix
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
getImaginaryPart() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns the imaginary part of this matrix
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns the imaginary part of this matrix
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns the imaginary part of this matrix
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
getImaginaryPart() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
getImports() - Method in class umontreal.iro.lecuyer.util.ClassFinder
Returns the current list of import declarations.
getImproperInstance() - Static method in class org.apache.commons.math.fraction.BigFractionFormat
Returns the default complex format for the current locale.
getImproperInstance(Locale) - Static method in class org.apache.commons.math.fraction.BigFractionFormat
Returns the default complex format for the given locale.
getImproperInstance() - Static method in class org.apache.commons.math.fraction.FractionFormat
Returns the default complex format for the current locale.
getImproperInstance(Locale) - Static method in class org.apache.commons.math.fraction.FractionFormat
Returns the default complex format for the given locale.
getIncGammaMaxIter() - Static method in class flanagan.analysis.Stat
 
getIncGammaTol() - Static method in class flanagan.analysis.Stat
 
getIndex(int) - Method in class jhplot.math.Sorting
Get the ascending order of one line.
getIndex() - Method in class jhplot.math.Sorting
Get the ascending order of all lines.
getIndex() - Method in exception org.apache.commons.math.exception.NonMonotonousSequenceException
Get the index of the wrong value.
getIndex() - Method in class org.apache.commons.math.linear.RealVector.Entry
Get the index of the entry.
getIndexCopy() - Method in class flanagan.math.Matrix
 
getIndexPointer() - Method in class flanagan.math.Matrix
 
getIndexReference() - Method in class flanagan.math.Matrix
 
getInflip() - Method in class jhplot.jadraw.JaLineObject
Returns the inflip property of this line object.
getInfo() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleSingularValueDecomposition
Returns the output flag
getInfo() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatSingularValueDecomposition
Returns the output flag
getInfo() - Method in class jhplot.io.FileRoot
Get the StreamerInfo
getInfo() - Static method in class jhplot.JHPlot
 
getInitialEstimates() - Method in class flanagan.analysis.ProbabilityPlot
 
getInitialEstimates() - Method in class flanagan.analysis.Regression
 
getInitialSeed() - Method in class flanagan.math.PsRandom
 
getInitialSteps() - Method in class flanagan.analysis.Regression
 
getInitialTime() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Get the initial integration time.
getInitString() - Method in class jhplot.HCellular
Return initialization string
getInitTime() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Returns the initialization time for this object.
getInitTime() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
Returns the last simulation time initStat was called.
getInnerColor() - Method in class jhplot.HPlot
Returns the color used to fill the shaded triangles.
getInnerList() - Method in class umontreal.iro.lecuyer.util.TransformingList
 
getInsertionTime() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat.Node
Returns the insertion time of the element in this node.
getInstance() - Static method in class org.apache.commons.math.complex.ComplexField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math.complex.ComplexFormat
Returns the default complex format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math.complex.ComplexFormat
Returns the default complex format for the given locale.
getInstance() - Static method in class org.apache.commons.math.fraction.BigFractionField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math.fraction.FractionField
Get the unique instance.
getInstance() - Static method in class org.apache.commons.math.geometry.Vector3DFormat
Returns the default 3D vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math.geometry.Vector3DFormat
Returns the default 3D vector format for the given locale.
getInstance() - Static method in class org.apache.commons.math.linear.RealVectorFormat
Returns the default real vector format for the current locale.
getInstance(Locale) - Static method in class org.apache.commons.math.linear.RealVectorFormat
Returns the default real vector format for the given locale.
getInstance(int) - Static method in class org.apache.commons.math.ode.nonstiff.AdamsNordsieckTransformer
Get the Nordsieck transformer for a given number of steps.
getInstance() - Static method in class org.apache.commons.math.ode.sampling.DummyStepHandler
Get the only instance.
getInstance() - Static method in class org.apache.commons.math.util.BigRealField
Get the unique instance.
getInstance() - Static method in class org.netlib.arpack.ARPACK
 
getInstance() - Static method in class org.netlib.blas.BLAS
 
getInstance() - Static method in class org.netlib.lapack.LAPACK
 
getInstanceFromMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Creates a new instance of a Bernoulli distribution with parameter p estimated using the maximum likelihood method, from the m observations x[i], i = 0, 1,…, m - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Creates a new instance of a beta distribution with parameters α and β over the interval [0, 1] estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Creates a new instance of a symmetrical beta distribution with parameter α estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Creates a new instance of a binomial distribution with both parameters n and p estimated using the maximum likelihood method, from the m observations x[i], i = 0, 1,…, m - 1.
getInstanceFromMLE(int[], int, int) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Creates a new instance of a binomial distribution with given (fixed) parameter n, and with parameter p estimated by the maximum likelihood method based on the m observations x[i], i = 0, 1,…, m - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.CauchyDist
Creates a new instance of a Cauchy distribution with parameters α and β estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ChiDist
Creates a new instance of a chi distribution with parameter ν estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Creates a new instance of a chi-square distribution with parameter n estimated using the maximum likelihood method based on the m observations x[i], i = 0, 1,…, m - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ErlangDist
Creates a new instance of an Erlang distribution with parameters k and λ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Creates a new instance of an exponential distribution with parameter λ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Creates a new instance of an extreme value distribution with parameters α and λ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int, double) - Static method in class umontreal.iro.lecuyer.probdist.FrechetDist
Given δ = delta, creates a new instance of a Fréchet distribution with parameters α and β estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Creates a new instance of a gamma distribution with parameters α and λ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.GeometricDist
Creates a new instance of a geometric distribution with parameter p estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Creates a new instance of an Gumbel distribution with parameters β and δ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1, assuming that β > 0.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Creates a new instance of a hyperbolic secant distribution with parameters μ and σ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Creates a new instance of the inverse gamma distribution with parameters α and β estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Creates a new instance of an inverse gaussian distribution with parameters μ and λ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Creates a new instance of a Laplace distribution with parameters μ and β estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Creates a new instance of a logarithmic distribution with parameter θ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.LogisticDist
Creates a new instance of a logistic distribution with parameters α and λ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Creates a new instance of a log-logistic distribution with parameters α and β estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.LognormalDist
Creates a new instance of a lognormal distribution with parameters μ and σ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(int[], int, double) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Creates a new instance of a negative binomial distribution with parameters γ = gamma given and hat(p) estimated using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Creates a new instance of a negative binomial distribution with parameters γ and p estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Creates a new instance of a normal distribution with parameters μ and σ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
NOT IMPLEMENTED.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ParetoDist
Creates a new instance of a Pareto distribution with parameters α and β estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.PascalDist
Creates a new instance of a Pascal distribution with parameters n and p estimated using the maximum likelihood method based on the m observations x[i], i = 0, 1,…, m - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Creates a new instance of a Pearson V distribution with parameters α and β estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Creates a new instance of a Pearson VI distribution with parameters α1, α2 and β, estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.PoissonDist
Creates a new instance of a Poisson distribution with parameter λ estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int, double, double) - Static method in class umontreal.iro.lecuyer.probdist.PowerDist
Creates a new instance of a power distribution with parameters a and b, with c estimated using the maximum likelihood method based on the n observations x[i], i = 0,…, n - 1.
getInstanceFromMLE(double[], int, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Creates a new instance of a Rayleigh distribution with parameters a and hat(β).
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.StudentDist
Creates a new instance of a Student t-distribution with parameter n estimated using the maximum likelihood method based on the m observations x[i], i = 0, 1,…, m - 1.
getInstanceFromMLE(double[], int, double, double) - Static method in class umontreal.iro.lecuyer.probdist.TriangularDist
Creates a new instance of a triangular distribution with parameters a and b.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.UniformDist
Creates a new instance of a uniform distribution with parameters a and b estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Creates a new instance of a discrete uniform distribution over integers with parameters i and j estimated using the maximum likelihood method based on the n observations x[k], k = 0, 1,…, n - 1.
getInstanceFromMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Creates a new instance of a Weibull distribution with parameters α, λ and δ = 0 estimated using the maximum likelihood method based on the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLE1(int[], int, double) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Creates a new instance of a negative binomial distribution with parameters p given and hat(γ) estimated using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getInstanceFromMLEmin(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Similar to getInstanceFromMLE, but for the case β < 0.
getInt(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getInt(int) - Method in class umontreal.iro.lecuyer.util.BitVector
Returns an int containing all the bits in the interval [pos×32,pos×32 + 31].
getIntArrayList() - Method in class jhplot.P0I
Get data in form of IntArrayList from cern.colt package
getIntegerArrayList() - Method in class jhplot.P0I
Get data in form of DoubleArrayList from cern.colt package
getIntegral() - Method in class jhpro.stat.DataKeeper
Calculate integral, summing up all values
getIntegralSum() - Method in class flanagan.integration.Integration
 
getIntercept() - Method in class jhplot.stat.LinReg
Get Intercept
getIntercept() - Method in class jhplot.stat.LinRegWeighted
Get Intercept
getIntercept() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the intercept of the estimated regression line.
getInterceptError() - Method in class jhplot.stat.LinReg
Get the standard error on intercept
getInterceptError() - Method in class jhplot.stat.LinRegWeighted
Get the standard error on intercept
getInterceptStdErr() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the standard error of the intercept estimate, usually denoted s(b0).
getInternalValues() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns the internal storage array.
getInterpolatedDerivatives() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Get the derivatives of the state vector of the interpolated point.
getInterpolatedDerivatives() - Method in interface org.apache.commons.math.ode.sampling.StepInterpolator
Get the derivatives of the state vector of the interpolated point.
getInterpolatedDyDp() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Get the partial derivatives of the state vector with respect to the ODE parameters of the interpolated point.
getInterpolatedDyDpDot() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Get the time derivatives of the jacobian of the state vector with respect to the ODE parameters of the interpolated point.
getInterpolatedDyDy0() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Get the partial derivatives of the state vector with respect to the initial state of the interpolated point.
getInterpolatedDyDy0Dot() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Get the time derivatives of the jacobian of the state vector with respect to the initial state of the interpolated point.
getInterpolatedState() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Get the state vector of the interpolated point.
getInterpolatedState() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Get the state vector of the interpolated point.
getInterpolatedState() - Method in interface org.apache.commons.math.ode.sampling.StepInterpolator
Get the state vector of the interpolated point.
getInterpolatedStateVariation() - Method in class org.apache.commons.math.ode.sampling.NordsieckStepInterpolator
Get the state vector variation from current to interpolated state.
getInterpolatedTime() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Get the time of the interpolated point.
getInterpolatedTime() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Get the time of the interpolated point.
getInterpolatedTime() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Get the time of the interpolated point.
getInterpolatedTime() - Method in interface org.apache.commons.math.ode.sampling.StepInterpolator
Get the time of the interpolated point.
getInterpolatedY() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Get the state vector of the interpolated point.
getInterpolatedYDot() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Get the time derivatives of the state vector of the interpolated point.
getInterpolatingPoints() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating points array.
getInterpolatingValues() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionLagrangeForm
Returns a copy of the interpolating values array.
getInterQuartileRange() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
Returns the interquartile range of the observations, defined as the difference between the third and first quartiles.
getIntProperty(int) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getInverse() - Method in interface org.apache.commons.math.linear.DecompositionSolver
Get the inverse (or pseudo-inverse) of the decomposed matrix.
getInverse() - Method in interface org.apache.commons.math.linear.FieldDecompositionSolver
Get the inverse (or pseudo-inverse) of the decomposed matrix.
getInversionCheck() - Method in class flanagan.analysis.Regression
 
getIsospin() - Method in class hephysics.particle.HEParticle
Get isospin
getItemCount(int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the number of data items for a series.
getIterationCount() - Method in interface org.apache.commons.math.ConvergingAlgorithm
Deprecated. Get the number of iterations in the last run of the algorithm.
getIterationCount() - Method in class org.apache.commons.math.ConvergingAlgorithmImpl
Deprecated. Get the number of iterations in the last run of the algorithm.
getIterationCount() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Get the number of iterations in the last run of the algorithm.
getIterationMonitor() - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterativeSolver
 
getIterationMonitor() - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterativeSolver
Gets the iteration monitor
getIterationMonitor() - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterativeSolver
 
getIterationMonitor() - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterativeSolver
Gets the iteration monitor
getIterationReporter() - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
getIterationReporter() - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Returns current iteration reporter
getIterationReporter() - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
getIterationReporter() - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Returns current iteration reporter
getIterations() - Method in exception cern.colt.matrix.tdouble.algo.solver.IterativeSolverDoubleNotConvergedException
Gets the number of iterations used when this exception was thrown
getIterations() - Method in exception cern.colt.matrix.tfloat.algo.solver.IterativeSolverFloatNotConvergedException
Gets the number of iterations used when this exception was thrown
getIterations() - Method in interface jhplot.math.num.IterativeMethod.IterativeState
Access the current iteration.
getIterations() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in class org.apache.commons.math.optimization.linear.AbstractLinearOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in interface org.apache.commons.math.optimization.linear.LinearOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in interface org.apache.commons.math.optimization.MultivariateRealOptimizer
Get the number of iterations realized by the algorithm.
getIterations() - Method in class org.apache.commons.math.optimization.univariate.BracketFinder
 
getIterator(int[], Object[]) - Static method in class jhplot.math.SortUtils
Answer iterator, which iterates over specified data array according to the specified permutation, that is data[p[0]],..,data[p[data.length-1]]
getIterator(int[], List) - Static method in class jhplot.math.SortUtils
Answer iterator, which iterates over specified data list according to the specified permutation, that is data.get(p[0]),..,data.get(p[data.length-1])
getITree() - Method in class jhplot.io.FileAida
Return ITree for further manipulations
getJ() - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Returns the parameter j.
getJ() - Method in class umontreal.iro.lecuyer.randvar.UniformIntGen
Returns the parameter j.
getJaAxes() - Method in class jhplot.HPlotJa
Get the current JaAxes frame
getJacobianEvaluations() - Method in class org.apache.commons.math.estimation.AbstractEstimator
Deprecated. Get the number of jacobian evaluations.
getJacobianEvaluations() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
Get the number of evaluations of the objective function jacobian .
getJacobianEvaluations() - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Get the number of evaluations of the objective function jacobian .
getJacobianEvaluations() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Get the number of evaluations of the objective function jacobian .
getJFreeChart() - Method in class umontreal.iro.lecuyer.charts.CategoryChart
Returns the JFreeChart object associated with this chart.
getJFreeChart() - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Returns the JFreeChart variable associated with this chart.
getJFreeChart() - Method in class umontreal.iro.lecuyer.charts.XYChart
Returns the JFreeChart object associated with this chart.
getJPanel() - Method in class jhplot.GHMargin
Return JPanel of this margin
getJPlot(int, int) - Method in class jhplot.HPlot
Get jplots for each graph
getJPlot() - Method in class jhplot.HPlot
Get jplots for each graph for current graph
getK() - Method in class umontreal.iro.lecuyer.probdist.ErlangDist
Returns the parameter k for this object.
getK() - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Returns the k associated with this object.
getK() - Method in class umontreal.iro.lecuyer.randvar.ErlangGen
Returns the parameter k of this object.
getK() - Method in class umontreal.iro.lecuyer.randvar.HypergeometricGen
Returns the k associated with this object.
getKayValue() - Method in class flanagan.analysis.Regression
 
getKey(int) - Method in class jhplot.io.FileRoot
Get a key using its index.
getKey(String) - Method in class jhplot.io.FileRoot
Get a key
getKey() - Method in class jhplot.io.RecordWriter
 
getKey() - Method in class jhplot.jadraw.JaKey
Get current key symbol.
getKeyColor() - Method in class jhplot.HKey
Get key color
getKeyColor() - Method in class jhplot.jadraw.JaKey
Get key color
getKeys() - Method in class jhplot.io.FileRoot
Return all keys of the current directory as a list.
getKeys() - Method in class jhplot.io.HDataBase
Returns an enumeration of all the keys in the database.
getKeysH1D() - Method in class jhplot.HBook
Get keys of all known H1D histograms.
getKeysH2D() - Method in class jhplot.HBook
Get keys of all known H2D histograms.
getKeySize() - Method in class jhplot.HKey
Get key size
getKeysP1D() - Method in class jhplot.HBook
Get keys of all known P1D containers.
getKeySpace() - Method in class jhplot.HKey
Get a space between the key and the text describing the key
getKeySpace() - Method in class jhplot.jadraw.JaKey
Get space between a text and the key
getKeyTextSpace() - Method in class jhplot.HPlotJa
Get current space between the key symbol and the text for legends
getKeyType() - Method in class jhplot.HKey
Get key type
getKnots() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialSplineFunction
Returns an array copy of the knot points.
getKnots() - Method in class umontreal.iro.lecuyer.functionfit.BSpline
Returns an array containing the knot vector (t0, tm-1).
getKurtosis() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the Kurtosis of the available values.
getKurtosisImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured kurtosis implementation.
getL() - Method in class cern.colt.matrix.linalg.CholeskyDecomposition
Returns the triangular factor, L.
getL() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns the lower triangular factor, L.
getL() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns the lower triangular factor, L.
getL() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleCholeskyDecomposition
Returns the triangular factor, L.
getL() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecomposition
Returns the lower triangular factor, L.
getL() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Returns the lower triangular factor, L.
getL() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleCholeskyDecomposition
Returns the triangular factor, L.
getL() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleLUDecomposition
Returns the lower triangular factor, L.
getL() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatCholeskyDecomposition
Returns the triangular factor, L.
getL() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecomposition
Returns the lower triangular factor, L.
getL() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Returns the lower triangular factor, L.
getL() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatCholeskyDecomposition
Returns the triangular factor, L.
getL() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatLUDecomposition
Returns the lower triangular factor, L.
getL() - Method in class jhplot.math.CholeskyDecomposition
Return triangular factor.
getL() - Method in class jhplot.math.LUDecomposition
Return lower triangular factor
getL() - Method in interface org.apache.commons.math.linear.CholeskyDecomposition
Returns the matrix L of the decomposition.
getL() - Method in class org.apache.commons.math.linear.CholeskyDecompositionImpl
Returns the matrix L of the decomposition.
getL() - Method in interface org.apache.commons.math.linear.FieldLUDecomposition
Returns the matrix L of the decomposition.
getL() - Method in class org.apache.commons.math.linear.FieldLUDecompositionImpl
Returns the matrix L of the decomposition.
getL() - Method in interface org.apache.commons.math.linear.LUDecomposition
Returns the matrix L of the decomposition.
getL() - Method in class org.apache.commons.math.linear.LUDecompositionImpl
Returns the matrix L of the decomposition.
getL() - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Returns the l associated with this object.
getL() - Method in class umontreal.iro.lecuyer.randvar.HypergeometricGen
Returns the l associated with this object.
getL1Distance(RealVector) - Method in class org.apache.commons.math.linear.AbstractRealVector
Distance between two vectors.
getL1Distance(double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Distance between two vectors.
getL1Distance(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Distance between two vectors.
getL1Distance(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Distance between two vectors.
getL1Distance(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Distance between two vectors.
getL1Distance(OpenMapRealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Distance between two vectors.
getL1Distance(RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Distance between two vectors.
getL1Distance(double[]) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Distance between two vectors.
getL1Distance(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Distance between two vectors.
getL1Distance(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Distance between two vectors.
getL1Norm() - Method in class org.apache.commons.math.linear.AbstractRealVector
Returns the L1 norm of the vector.
getL1Norm() - Method in class org.apache.commons.math.linear.ArrayRealVector
Returns the L1 norm of the vector.
getL1Norm() - Method in interface org.apache.commons.math.linear.RealVector
Returns the L1 norm of the vector.
getLabel() - Method in class umontreal.iro.lecuyer.charts.Axis
Returns the axis description.
getLabelColor() - Method in class jhplot.HPlot3D
Get label color
getLabelColor() - Method in class jhplot.jadraw.JaAxes
Get label color
getLabelDimension(FontMetrics, int) - Method in class jhplot.jadraw.JaAxes
Get the lastst lavel size
getLabelFont() - Method in class jhplot.jadraw.JaAxes
Get label font
getLabelOffset(int) - Method in class jhplot.HPlot3D
Get offset for labels on X
getLabelRotation() - Method in class jhplot.jadraw.JaAxes
Get label rotation
getLabelSpace(int) - Method in class jhplot.jadraw.JaAxes
Get label space
getLabelX() - Method in class jhplot.HPlotJa
Get labels on X
getLabelY() - Method in class jhplot.HPlotJa
Get label on Y
getLambda() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Returns the parameter λ of this object.
getLambda() - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Returns the value of λ for this object.
getLambda() - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Returns the parameter λ of this object.
getLambda() - Method in class umontreal.iro.lecuyer.probdist.GammaDist
Return the parameter λ for this object.
getLambda() - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Returns the parameter λ of this object.
getLambda() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Returns the value of λ for this object.
getLambda() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Returns the value of λ for this object.
getLambda() - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
Returns the parameter λ of this object.
getLambda() - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Returns the scale parameter λ of this object.
getLambda() - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
Returns the λ associated with this object.
getLambda() - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
Returns the parameter λ.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralGen
Returns the value of λ for this object.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.ExponentialGen
Returns the λ associated with this object.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.ExtremeValueGen
Deprecated. Returns the parameter λ of this object.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.GammaGen
Returns the parameter λ of this object.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.InverseGaussianGen
Returns the parameter λ of this object.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.JohnsonSBGen
Returns the λ associated with this object.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.JohnsonSUGen
Returns the λ associated with this object.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.LogisticGen
Returns the parameter λ of this object.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.NakagamiGen
Returns the scale parameter λ of this object.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.PoissonGen
Returns the λ associated with this object.
getLambda() - Method in class umontreal.iro.lecuyer.randvar.WeibullGen
Returns the parameter λ.
getLambda(DoubleMatrix2D) - Static method in class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Computes and returns the eigenvalues of sigma in decreasing order.
getLambda() - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Returns the eigenvalues of Σ in decreasing order.
getLanczosCoeff() - Static method in class flanagan.analysis.Stat
 
getLanczosGamma() - Static method in class flanagan.analysis.Stat
 
getLanczosN() - Static method in class flanagan.analysis.Stat
 
getLast() - Method in class umontreal.iro.lecuyer.simevents.LinkedListStat
 
getLastIndex() - Method in interface hep.aida.ref.tuple.FTupleEvent
 
getLastIndex() - Method in class hep.aida.ref.tuple.TupleEvent
 
getLastTime() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Returns the last update time for this object.
getLastValue() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Returns the value passed to this probe by the last call to its update method (or the initial value if update was never called after init).
getLatexFS() - Method in class jhplot.jadraw.JaLatexText
Returns the latexfs property of this text object.
getLatexPanel() - Method in class jhplot.jadraw.JaLatexText
Returns the Panel that holds the String specifying this LatexText.
getLegend() - Method in class jhplot.DrawOptions
Returns true if this line style should draw the name in the legend of the graph, false otherwise
getLegend(int) - Method in class jhplot.SPlot
Get the legend for a dataset, or null if there is none.
getLegendDataset(String) - Method in class jhplot.SPlot
Given a legend string, return the corresponding dataset or -1 if no legend was added with that legend string.
getLegendFont() - Method in class jhplot.HPlot
Returns the font used by the legend.
getLegendPos(int) - Method in class jhplot.HPlot
Returns the x or y coordinates (defined in pixels, relative to the size of the panel showing the graph) of the legend.
getLegendPosUse() - Method in class jhplot.HPlot
Returns whether or not we use the legend coordinates.
getLegendSpacing() - Method in class jhplot.HPlot
Returns the vertical spacing, between each line of the legend.
getLength() - Method in class org.apache.commons.math.genetics.AbstractListChromosome
Returns the length of the chromosome.
getLevyProcess() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Returns the Lévy process.
getLimit() - Method in class jhpro.stat.CLimits
Build a Confidence level.
getLimit(Random) - Method in class jhpro.stat.CLimits
Build a Confidence level with a custom Random() to build Poisson random numbers.
getLimitGuess() - Method in class jhpro.stat.limit.StatConfidence
Get limit guess
getLimits() - Method in class flanagan.interpolation.BiCubicSpline
 
getLimits() - Method in class flanagan.interpolation.BiCubicSplineFirstDerivative
 
getLimits() - Method in class flanagan.interpolation.BiCubicSplinePartialDerivative
 
getLimits() - Method in class flanagan.interpolation.CubicSpline
 
getLimits() - Method in class flanagan.interpolation.PolyCubicSpline
 
getLimits() - Method in class flanagan.interpolation.QuadriCubicSpline
 
getLimits() - Method in class flanagan.interpolation.TriCubicSpline
 
getLinearState() - Method in class umontreal.iro.lecuyer.rng.F2NL607
Returns the current state of the linear part of the stream, represented as an array of 19 integers.
getLineColor() - Method in class jhplot.FPR
Get line color
getLineParm() - Method in class jhplot.DrawOptions
Get all drawing parameters.
getLinePars() - Method in class jhplot.P1D
get LinePars class which holds graphical attributes
getLineWidth() - Method in class jhplot.HKey
Get a key line width
getLInfDistance(RealVector) - Method in class org.apache.commons.math.linear.AbstractRealVector
Distance between two vectors.
getLInfDistance(double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Distance between two vectors.
getLInfDistance(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Distance between two vectors.
getLInfDistance(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Distance between two vectors.
getLInfDistance(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Distance between two vectors.
getLInfDistance(RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Distance between two vectors.
getLInfDistance(double[]) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Distance between two vectors.
getLInfDistance(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Distance between two vectors.
getLInfDistance(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Distance between two vectors.
getLInfNorm() - Method in class org.apache.commons.math.linear.AbstractRealVector
Returns the L norm of the vector.
getLInfNorm() - Method in class org.apache.commons.math.linear.ArrayRealVector
Returns the L norm of the vector.
getLInfNorm() - Method in interface org.apache.commons.math.linear.RealVector
Returns the L norm of the vector.
getLinkPath() - Method in class hep.aida.ref.event.TreeEvent
 
getList() - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Returns the dataset list.
getListenableGraph() - Method in class jhplot.HGraph
Returns the current Listenable Graph
getLn10() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant ln(10).
getLn2() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant ln(2).
getLn2Split() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant ln(2) split in two pieces.
getLn5() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant ln(5).
getLn5Split() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant ln(5) split in two pieces.
getLNQb(int, double, double) - Method in class jhpro.stat.ConfidenceLevel
Get a histogram of a canonical -2lnQ plot for background hypothesis (full)
getLNQsb(int, double, double) - Method in class jhpro.stat.ConfidenceLevel
Get a histogram of a canonical -2lnQ plot for for signal and background hypothesis
getLo() - Method in exception org.apache.commons.math.exception.OutOfRangeException
 
getLo() - Method in class org.apache.commons.math.optimization.univariate.BracketFinder
 
getLocalizedMessage() - Method in exception org.apache.commons.math.exception.MathIllegalArgumentException
Gets the message in the system default locale.
getLocalizedMessage() - Method in exception org.apache.commons.math.exception.MathIllegalStateException
Gets the message in the system default locale.
getLocalizedMessage() - Method in interface org.apache.commons.math.exception.MathThrowable
Gets the message in the system default locale.
getLocalizedMessage() - Method in exception org.apache.commons.math.exception.MathUnsupportedOperationException
Gets the message in the system default locale.
getLocalizedMessage() - Method in exception org.apache.commons.math.MathException
Gets the message in the system default locale.
getLocalizedMessage() - Method in exception org.apache.commons.math.MathRuntimeException
Gets the message in the system default locale.
getLocalizedString(Locale) - Method in class org.apache.commons.math.exception.util.DummyLocalizable
Get the localized string.
getLocalizedString(Locale) - Method in interface org.apache.commons.math.exception.util.Localizable
Get the localized string.
getLocalizedString(Locale) - Method in enum org.apache.commons.math.exception.util.LocalizedFormats
Get the localized string.
getLocation() - Method in class jhplot.math.num.pdf.Weibull
Access the location parameter.
getLock() - Method in class hep.aida.ref.tree.Tree
 
getLong(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getLongFromTo(int, int) - Method in class cern.colt.bitvector.BitVector
Returns a long value representing bits of the receiver from index from to index to.
getLongFromTo(long[], int, int) - Static method in class cern.colt.bitvector.QuickBitVector
Returns a long value representing bits of a bitvector from index from to index to.
getLongFromTo(int, int) - Method in class cern.colt.matrix.tbit.BitVector
Returns a long value representing bits of the receiver from index from to index to.
getLongFromTo(long[], int, int) - Static method in class cern.colt.matrix.tbit.QuickBitVector
Returns a long value representing bits of a bitvector from index from to index to.
getLongName() - Method in enum umontreal.iro.lecuyer.util.TimeUnit
Returns the long name of this time unit.
getLongProperty(int) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getLower() - Method in class jhplot.math.num.pdf.Uniform
Access the lower parameter.
getLowerEdgeX(int) - Method in class jhplot.H2D
Get lower edge of the bin in X
getLowerEdgeX(int) - Method in class jhplot.HProf2D
Get lower edge of the bin in X
getLowerEdgeY(int) - Method in class jhplot.H2D
Get lower edge of the bins in Y
getLowerEdgeY(int) - Method in class jhplot.HProf2D
Get lower edge of the bins in Y
getLParticle() - Method in class hephysics.particle.HEParticle
Returns a light-weight particle class
getLT() - Method in interface org.apache.commons.math.linear.CholeskyDecomposition
Returns the transpose of the matrix L of the decomposition.
getLT() - Method in class org.apache.commons.math.linear.CholeskyDecompositionImpl
Returns the transpose of the matrix L of the decomposition.
getLtranspose() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleCholeskyDecomposition
 
getLtranspose() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleCholeskyDecomposition
Returns the triangular factor, L'.
getLtranspose() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatCholeskyDecomposition
 
getLtranspose() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatCholeskyDecomposition
Returns the triangular factor, L'.
getLU() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns a copy of the combined lower and upper triangular factor, LU.
getLU() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Returns a copy of the combined lower and upper triangular factor, LU.
getLU() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Returns a copy of the combined lower and upper triangular factor, LU.
getM() - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
Returns the parameter m of this object.
getM() - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Returns the m associated with this object.
getM() - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
Returns the value of m for this object.
getM() - Method in class umontreal.iro.lecuyer.randvar.FisherFGen
Returns the parameter p of this object.
getM() - Method in class umontreal.iro.lecuyer.randvar.HypergeometricGen
Returns the m associated with this object.
getM() - Method in class umontreal.iro.lecuyer.randvar.TriangularGen
Returns the value of m for this object.
getMainSetDimension() - Method in interface org.apache.commons.math.ode.ExtendedFirstOrderDifferentialEquations
Return the dimension of the main set of equations.
getMajorVersion() - Static method in class cern.colt.Version
Returns the major version of this release.
getMargin() - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Returns the margin which is a percentage amount by which the bars are trimmed.
getMarginBackground() - Method in class jhplot.GHPanel
Get color for all global margins
getMarginBottom() - Method in class jhplot.HPlot
Returns the distance between the bottom-border of the panel and the bottom X-axis.
getMarginBottom() - Method in class jhplot.HPlotJa
Get size of bottom margin
getMarginBottom() - Method in class jhplot.jadraw.JaAxes
Get bottom margin
getMarginLeft() - Method in class jhplot.HPlot
Returns the distance between the left-border of the panel and the left Y-axis.
getMarginLeft() - Method in class jhplot.HPlotJa
Get margin from left side
getMarginLeft() - Method in class jhplot.jadraw.JaAxes
Get left margin
getMarginPanelBottom() - Method in class jhplot.GHPanel
get JPanel for bottom margin
getMarginPanelCenter() - Method in class jhplot.GHPanel
get JPanel for central with drawings
getMarginPanelLeft() - Method in class jhplot.GHPanel
get JPanel for left margin
getMarginPanelRight() - Method in class jhplot.GHPanel
get JPanel for right margin
getMarginPanelTop() - Method in class jhplot.GHPanel
get JPanel for top margin
getMarginRight() - Method in class jhplot.HPlot
Returns the distance between the right-border of the panel and the right Y-axis.
getMarginRight() - Method in class jhplot.HPlotJa
Get margin from right
getMarginRight() - Method in class jhplot.jadraw.JaAxes
Get right margin
getMarginSizeBottom() - Method in class jhplot.GHPanel
Get size of the bottom margin as ratio to the main panel
getMarginSizeLeft() - Method in class jhplot.GHPanel
Get the size of left margin terms of the ratio to the main panel
getMarginSizeRight() - Method in class jhplot.GHPanel
Get the size of right margin of the global canvas in terms of the ratio to thye global canvas
getMarginSizeTop() - Method in class jhplot.GHPanel
Get size of the top margin of global canvas in terms of ratio to the main panel
getMarginTop() - Method in class jhplot.HPlot
Returns the distance between the top-border of the panel and the top X-axis.
getMarginTop() - Method in class jhplot.HPlotJa
Get the size of the top margin
getMarginTop() - Method in class jhplot.jadraw.JaAxes
Get top margin
getMarginX() - Method in class jhplot.HPlotJa
Get margin in X between pads
getMarginY() - Method in class jhplot.HPlotJa
Get space between any 2 plots in Y
getMarksType(int) - Method in class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Returns the mark type associated with the series-th data series.
getMarksType(int) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Returns the mark type associated with the seriesth data series.
getMass() - Method in class hephysics.particle.LParticle
Get a mass
getMatrix() - Method in class org.apache.commons.math.geometry.Rotation
Get the 3X3 matrix corresponding to the instance
getMatrixCheck() - Method in class flanagan.math.Matrix
 
getMax() - Method in class jhplot.F1D
Get the maximum value in X
getMax() - Method in class jhplot.FND
Get the maximum value in X
getMax() - Method in class jhplot.H1D
Get Maximum value of axis
getMax() - Method in class jhplot.HProf1D
Get Maximum value of axis
getMax(int) - Method in class jhplot.jadraw.JaAxes
Get max value
getMax() - Method in class jhplot.P0D
Returns the maximum value.
getMax() - Method in class jhplot.P0I
Returns the maximum value.
getMax(int) - Method in class jhplot.P1D
Returns the maximum value in the range.
getMax(int) - Method in class jhplot.P2D
Returns the maximum value in the range.
getMax(int) - Method in class jhplot.P3D
Returns the maximum value in the range.
getMax() - Method in class jhplot.PND
Get min value
getMax() - Method in class jhplot.PNI
Get min value
getMax() - Method in class jminhep.cluster.DataHolder
Get Max values of the data
getMax() - Method in exception org.apache.commons.math.exception.NumberIsTooLargeException
 
getMax() - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
 
getMax() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the maximum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMax() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the maximum of the ith entries of the arrays that correspond to each multivariate sample
getMax() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the maximum of the available values
getMax() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getMax() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the maximum of the values that have been added.
getMax() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the maximum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMax() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the maximum of the values that have been added.
getMaxAbsoluteResidual() - Method in class jhplot.stat.LinReg
Get max absolute residual
getMaxCheckInterval() - Method in class org.apache.commons.math.ode.events.EventState
Get the maximal time interval between events handler checks.
getMaxEvaluations() - Method in exception org.apache.commons.math.MaxEvaluationsExceededException
Get the maximal number of evaluations allowed.
getMaxEvaluations() - Method in class org.apache.commons.math.ode.AbstractIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math.ode.ODEIntegrator
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math.optimization.MultivariateRealOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
Get the maximal number of functions evaluations.
getMaxEvaluations() - Method in interface org.apache.commons.math.optimization.UnivariateRealOptimizer
Get the maximal number of functions evaluations.
getMaxGrowth() - Method in class org.apache.commons.math.ode.MultistepIntegrator
Get the maximal growth factor for stepsize control.
getMaxGrowth() - Method in class org.apache.commons.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the maximal growth factor for stepsize control.
getMaximalIterationCount() - Method in interface org.apache.commons.math.ConvergingAlgorithm
Deprecated. Get the upper limit for the number of iterations.
getMaximalIterationCount() - Method in class org.apache.commons.math.ConvergingAlgorithmImpl
Deprecated. Get the upper limit for the number of iterations.
getMaximalIterationCount() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Get the upper limit for the number of iterations.
getMaxImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured maximum implementation.
getMaxImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured maximum implementation
getMaxImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured maximum implementation
getMaximum() - Method in class flanagan.math.ArrayMaths
 
getMaximum() - Method in class flanagan.math.Maximisation
 
getMaximum_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_byte() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_Byte() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_char() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_Character() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_double() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_Double() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_Float() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_float() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_int() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_Integer() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_long() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_Long() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_short() - Method in class flanagan.math.ArrayMaths
 
getMaximum_as_Short() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_byte() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_Byte() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_double() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_Double() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_float() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_Float() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_int() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_Integer() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_long() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_Long() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_short() - Method in class flanagan.math.ArrayMaths
 
getMaximumDifference_as_Short() - Method in class flanagan.math.ArrayMaths
 
getMaximumIndex() - Method in class flanagan.math.ArrayMaths
 
getMaximumIterations() - Method in class jhplot.math.num.IterativeMethod
Access the maximum number of iterations.
getMaximumIterations() - Method in class jhplot.math.num.root.Bracket
Access the maximum number of iterations.
getMaximumLikelihoodEstimate(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. 
getMaximumLikelihoodEstimate(double[][], int, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
Deprecated. 
getMaximumLikelihoodEstimate(int[][], int, int, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Deprecated. 
getMaximumLikelihoodEstimate(int[][], int, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Deprecated. 
getMaximumLikelihoodEstimateMu(double[][], int, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Deprecated. 
getMaximumLikelihoodEstimateSigma(double[][], int, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Deprecated. 
getMaximumRelativeError() - Method in class jhplot.math.num.IterativeMethod
Access the maximum relative error.
getMaxIndex() - Method in class jhplot.P0D
Returns index corresponding to maximum value.
getMaxIndex() - Method in class jhplot.P0I
Returns index corresponding to maximum value.
getMaxIndex(int) - Method in class jhplot.P1D
Returns the index of maximum value in the range.
getMaxIndex() - Method in class org.apache.commons.math.linear.AbstractRealVector
Get the index of the maximum entry.
getMaxIter() - Method in class jhplot.HCellular
Returns the maximum generation number for GA evolutions
getMaxIterationCount() - Method in class org.apache.commons.math.ode.events.EventState
Get the upper limit in the iteration count for event localization.
getMaxIterations() - Method in class cern.colt.matrix.tdouble.algo.solver.DefaultDoubleIterationMonitor
Returns maximum number of iterations to permit
getMaxIterations() - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Returns the maximum number of iterations
getMaxIterations() - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
 
getMaxIterations() - Method in class cern.colt.matrix.tfloat.algo.solver.DefaultFloatIterationMonitor
Returns maximum number of iterations to permit
getMaxIterations() - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Returns the maximum number of iterations
getMaxIterations() - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
 
getMaxIterations() - Method in exception org.apache.commons.math.MaxIterationsExceededException
Get the maximal number of iterations allowed.
getMaxIterations() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in class org.apache.commons.math.optimization.linear.AbstractLinearOptimizer
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in interface org.apache.commons.math.optimization.linear.LinearOptimizer
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Get the maximal number of iterations of the algorithm.
getMaxIterations() - Method in interface org.apache.commons.math.optimization.MultivariateRealOptimizer
Get the maximal number of iterations of the algorithm.
getMaxKnot() - Method in class umontreal.iro.lecuyer.functionfit.BSpline
Returns the knot maximal value.
getMaxLocation() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Return the maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Return the maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Return maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
getMaxLocation() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
getMaxLocation() - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Return the maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Return the maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Return maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
getMaxLocation() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
getMaxLocation() - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
getMaxLocation() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
getMaxLocation() - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tint.IntMatrix1D
Return the maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tint.IntMatrix2D
Return the maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tint.IntMatrix3D
Return maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
getMaxLocation() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
getMaxLocation() - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
getMaxLocation() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Return the maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Return the maximum value of this matrix together with its location
getMaxLocation() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Return maximum value of this matrix together with its location
getMaxNumberOfSubticsLog() - Method in class jhplot.HPlot
Returns the maximum number of subticks for log scale (default is 10).
getMaxOrderForSumOfPowers() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns Integer.MAX_VALUE, the maximum order k for which sums of powers are retrievable.
getMaxOrderForSumOfPowers() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the maximum order k for which sums of powers are retrievable, as specified upon instance construction.
getMaxOrderForSumOfPowers() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns Integer.MAX_VALUE, the maximum order k for which sums of powers are retrievable.
getMaxOrderForSumOfPowers() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the maximum order k for which sums of powers are retrievable, as specified upon instance construction.
getMaxOrderForSumOfPowers() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns Integer.MAX_VALUE, the maximum order k for which sums of powers are retrievable.
getMaxOrderForSumOfPowers() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the maximum order k for which sums of powers are retrievable, as specified upon instance construction.
getMaxStep() - Method in class org.apache.commons.math.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the maximal step.
getMaxTest() - Method in class flanagan.math.Maximisation
 
getMaxValue(int) - Method in class jhplot.HPlot
Returns the maximum data value for the specified axis.
getMaxValue() - Method in class jhplot.stat.Interpolator
Get min value of data in X
getMaxValue() - Method in class org.apache.commons.math.linear.AbstractRealVector
Get the value of the maximum entry.
getMaxX() - Method in class jhplot.F2D
Get Max value in X
getMaxX() - Method in class jhplot.F3D
Get Max value in X
getMaxX() - Method in class jhplot.H2D
Get max value of axis in X
getMaxX() - Method in class jhplot.HProf2D
Get max value of axis in X
getMaxX() - Method in class jhplot.stat.LinReg
Get a maximum value for X
getMaxX() - Method in class jhplot.stat.LinRegWeighted
Get a maximum value for X
getMaxY() - Method in class jhplot.F2D
Get Max value in Y
getMaxY() - Method in class jhplot.F3D
Get Max value in Y
getMaxY() - Method in class jhplot.H2D
Get max value of Y axis
getMaxY() - Method in class jhplot.HProf2D
Get max value of Y axis
getMaxY() - Method in class jhplot.stat.LinReg
Get maximum value in Y
getMaxY() - Method in class jhplot.stat.LinRegWeighted
Get maximum value in Y
getMaxZ() - Method in class jhplot.F3D
Set Max value in Z
getMColor() - Method in class jhplot.GHMargin
Get the text color
getMean() - Method in class hep.aida.tdouble.ref.DoubleHistogram1DContents
 
getMean() - Method in class hep.aida.tfloat.ref.FloatHistogram1DContents
 
getMean() - Method in class jhplot.math.num.pdf.Exponential
Access the mean.
getMean() - Method in class jhplot.math.num.pdf.Laplace
Access the mean.
getMean() - Method in class jhplot.math.num.pdf.Logistic
Access the mean.
getMean() - Method in class jhplot.math.num.pdf.LogNormal
Access the mean.
getMean() - Method in class jhplot.math.num.pdf.NegativeBinomial
Get mean value.
getMean() - Method in class jhplot.math.num.pdf.Normal
Access the mean.
getMean() - Method in class jhplot.math.num.pdf.Poisson
Access the mean.
getMean(int) - Method in class jhplot.stat.PCA
Get means for the component k
getMean() - Method in interface org.apache.commons.math.distribution.ExponentialDistribution
Access the mean.
getMean() - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Access the mean.
getMean() - Method in interface org.apache.commons.math.distribution.NormalDistribution
Access the mean.
getMean() - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Access the mean.
getMean() - Method in interface org.apache.commons.math.distribution.PoissonDistribution
Get the mean for the distribution.
getMean() - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Get the Poisson mean for the distribution.
getMean() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMean() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the mean of the ith entries of the arrays that correspond to each multivariate sample
getMean() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the arithmetic mean of the available values
getMean() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getMean() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the mean of the values that have been added.
getMean() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the mean of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMean() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the mean of the values that have been added.
getMean() - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
 
getMean(double) - Static method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Returns the mean E[X] = p of the Bernoulli distribution with parameter p.
getMean() - Method in class umontreal.iro.lecuyer.probdist.BetaDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Computes and returns the mean E[X] = α/(α + β) of the beta distribution with parameters α and β, over the interval [0, 1].
getMean(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Computes and returns the mean E[X] = ( + )/(α + β) of the beta distribution with parameters α and β over the interval [a, b].
getMean() - Method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
 
getMean(double) - Static method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Computes and returns the mean E[X] = 1/2 of the symmetrical beta distribution with parameter α.
getMean() - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
 
getMean(int, double) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Computes the mean E[X] = np of the binomial distribution with parameters n and p.
getMean() - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.CauchyDist
Throws an exception since the mean does not exist.
getMean() - Method in class umontreal.iro.lecuyer.probdist.ChiDist
 
getMean(int) - Static method in class umontreal.iro.lecuyer.probdist.ChiDist
Computes and returns the mean of the chi distribution with parameter ν.
getMean() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
 
getMean(int) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Computes and returns the mean E[X] = n of the chi-square distribution with parameter n.
getMean() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Computes and returns the mean E[X] = ν + λ of the noncentral chi-square distribution with parameters ν = nu and λ = lambda.
getMean() - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Returns the mean.
getMean() - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
 
getMean(int) - Static method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Returns the mean of the distribution with parameter n.
getMean() - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
Computes the mean E[X] = ∑i=1npixi of the distribution.
getMean() - Method in interface umontreal.iro.lecuyer.probdist.Distribution
Returns the mean of the distribution function.
getMean() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
 
getMean(int, double) - Static method in class umontreal.iro.lecuyer.probdist.ErlangDist
Computes and returns the mean, E[X] = k/λ, of the Erlang distribution with parameters k and λ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
 
getMean(double) - Static method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Computes and returns the mean, E[X] = 1/λ, of the exponential distribution with parameter λ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated.  
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Computes and returns the mean, E[X] = α + γ/λ, of the extreme value distribution with parameters α and λ, where γ = 0.5772156649 is the Euler-Mascheroni constant.
getMean() - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
 
getMean(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Computes and returns the mean E[X] = μ + β(1 + γ2/2) of the fatigue life distribution with parameters μ, β and γ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
 
getMean(int, int) - Static method in class umontreal.iro.lecuyer.probdist.FisherFDist
Computes and returns the mean E[X] = m/(m - 2) of the Fisher F distribution with parameters n and m.
getMean() - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
.
getMean() - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
 
getMean(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FrechetDist
Returns the mean of the Fréchet distribution with parameters α, β and δ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.GammaDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Computes and returns the mean E[X] = α/λ of the gamma distribution with parameters α and λ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
 
getMean(double) - Static method in class umontreal.iro.lecuyer.probdist.GeometricDist
Computes and returns the mean E[X] = (1 - p)/p of the geometric distribution with parameter p.
getMean() - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Returns the mean, E[X] = δ + γβ, of the Gumbel distribution with parameters β and δ, where γ = 0.5772156649015329 is the Euler-Mascheroni constant.
getMean() - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Computes and returns the mean E[X] = μ + σ(2 / π)1/2.
getMean() - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Computes and returns the mean E[X] = μ of the hyperbolic secant distribution with parameters μ and σ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
 
getMean(int, int, int) - Static method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Computes and returns the mean E[X] = km/l of the Hypergeometric distribution with parameters m, l and k.
getMean() - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Returns the mean E[X] = β/(α - 1) of the inverse gamma distribution with shape parameter α and scale parameter β.
getMean() - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Returns the mean E[X] = μ of the inverse gaussian distribution with parameters μ and λ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
 
getMean(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Computes and returns the mean of the Johnson SU distribution with parameters γ, δ, ξ and λ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Computes and returns the mean E[X] = μ of the Laplace distribution with parameters μ and β.
getMean() - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
 
getMean(double) - Static method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Computes and returns the mean of the logarithmic distribution with parameter θ = theta.
getMean() - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LogisticDist
Computes and returns the mean E[X] = α of the logistic distribution with parameters α and λ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Computes and returns the mean of the log-logistic distribution with parameters α and β.
getMean() - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LognormalDist
Computes and returns the mean E[X] = eμ+σ2/2 of the lognormal distribution with parameters μ and σ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
 
getMean(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NakagamiDist
.
getMean() - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Computes and returns the mean E[X] = γ(1 - p)/p of the negative binomial distribution with parameters γ and p.
getMean() - Method in class umontreal.iro.lecuyer.probdist.NormalDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Computes and returns the mean E[X] = μ of the normal distribution with parameters μ and σ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
 
getMean(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Returns the mean E[X] = μ + δβ/γ of the normal inverse gaussian distribution with parameters α, β, μ and δ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ParetoDist
Computes and returns the mean E[X] = αβ/(α - 1) of the Pareto distribution with parameters α and β.
getMean() - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Computes and returns the mean E[X] = β/(α - 1) of a Pearson V distribution with shape parameter α and scale parameter β.
getMean() - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
 
getMean(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Computes and returns the mean E[X] = (βα1)/(α2 - 1) of a Pearson VI distribution with shape parameters α1 and α2, and scale parameter β.
getMean() - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
 
getMean() - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
 
getMean(double) - Static method in class umontreal.iro.lecuyer.probdist.PoissonDist
Computes and returns the mean E[X] = λ of the Poisson distribution with parameter λ.
getMean() - Method in class umontreal.iro.lecuyer.probdist.PowerDist
 
getMean(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.PowerDist
Returns the mean a + (b - a)c/(c + 1) of the power distribution with parameters a, b and c.
getMean() - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Returns the mean a + β(π/2)1/2 of the Rayleigh distribution with parameters a and β.
getMean() - Method in class umontreal.iro.lecuyer.probdist.StudentDist
 
getMean(int) - Static method in class umontreal.iro.lecuyer.probdist.StudentDist
Returns the mean E[X] = 0 of the Student t-distribution with parameter n.
getMean() - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
 
getMean(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.TriangularDist
Computes and returns the mean E[X] = (a + b + m)/3 of the triangular distribution with parameters a, b, m.
getMean() - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Returns an approximation of the mean computed with the Simpson 1/3 numerical integration rule.
getMean() - Method in class umontreal.iro.lecuyer.probdist.UniformDist
 
getMean(double, double) - Static method in class umontreal.iro.lecuyer.probdist.UniformDist
Computes and returns the mean E[X] = (a + b)/2 of the uniform distribution with parameters a and b.
getMean() - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
 
getMean(int, int) - Static method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Computes and returns the mean E[X] = (i + j)/2 of the discrete uniform distribution.
getMean() - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
 
getMean(int) - Static method in class umontreal.iro.lecuyer.probdist.WatsonUDist
Returns the mean of the Watson U distribution with parameter n.
getMean() - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
 
getMean(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Computes and returns the mean of the Weibull distribution with parameters α, λ and δ.
getMean() - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
 
getMean(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Return the mean vector E[X] = (μ1, μ2) of the binormal distribution.
getMean() - Method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
 
getMean(int, double) - Static method in class umontreal.iro.lecuyer.probdistmulti.BiStudentDist
Returns the mean vector E[X] = (0, 0) of the bivariate Student's t distribution.
getMean() - Method in class umontreal.iro.lecuyer.probdistmulti.ContinuousDistributionMulti
Returns the mean vector of the distribution, defined as μi = E[Xi].
getMean() - Method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
 
getMean(double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
Computes the mean E[X] = αi/α0 of the Dirichlet distribution with parameters (α1,...,αd), where α0 = ∑i=1dαi.
getMean() - Method in class umontreal.iro.lecuyer.probdistmulti.DiscreteDistributionIntMulti
Returns the mean vector of the distribution, defined as μi = E[Xi].
getMean() - Method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
 
getMean(int, double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Computes the mean E[Xi] = npi of the multinomial distribution with parameters n and (p1,...,pd).
getMean() - Method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
 
getMean(double[], double[][]) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Returns the mean E[X] = μ of the multinormal distribution with parameters μ and Σ.
getMean() - Method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
 
getMean(double, double[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Computes the mean E[X] = γpi/p0 of the negative multinomial distribution with parameters γ and (p1,...,pd).
getMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured mean implementation.
getMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured mean implementation
getMeanImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured mean implementation
getMeans() - Method in class jhplot.stat.StatShape
Get weighted means in X and Y
getMeanSquareError() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the sum of squared errors divided by the degrees of freedom, usually abbreviated MSE.
getMeanX() - Method in class jhplot.H2D
Get mean on X.
getMeanX() - Method in class jhplot.HProf2D
Get mean on X.
getMeanY() - Method in class jhplot.H2D
Get mean on Y
getMeanY() - Method in class jhplot.HProf2D
Get mean on Y
getMeasuredValue() - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Deprecated. Get the measured value
getMeasurements() - Method in interface org.apache.commons.math.estimation.EstimationProblem
Deprecated. Get the measurements of an estimation problem.
getMeasurements() - Method in class org.apache.commons.math.estimation.SimpleEstimationProblem
Deprecated. Get the measurements of an estimation problem.
getMedian() - Method in class jhplot.math.num.pdf.Cauchy
Access the location parameter.
getMedian() - Method in interface org.apache.commons.math.distribution.CauchyDistribution
Access the median.
getMedian() - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Access the median.
getMedian() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
Returns the n/2th item of the sorted observations when the number of items is odd, and the mean of the n/2th and the (n/2 + 1)th items when the number of items is even.
getMedian(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
Returns the n/2th item of the array obs when the number of items is odd, and the mean of the n/2th and the (n/2 + 1)th items when the number of items is even.
getMessage(Locale) - Method in exception org.apache.commons.math.exception.MathIllegalArgumentException
Get the message in a specified locale.
getMessage() - Method in exception org.apache.commons.math.exception.MathIllegalArgumentException
Gets the message in a conventional US locale.
getMessage(Locale) - Method in exception org.apache.commons.math.exception.MathIllegalStateException
Get the message in a specified locale.
getMessage() - Method in exception org.apache.commons.math.exception.MathIllegalStateException
Gets the message in a conventional US locale.
getMessage(Locale) - Method in interface org.apache.commons.math.exception.MathThrowable
Gets the message in a specified locale.
getMessage() - Method in interface org.apache.commons.math.exception.MathThrowable
Gets the message in a conventional US locale.
getMessage(Locale) - Method in exception org.apache.commons.math.exception.MathUnsupportedOperationException
Get the message in a specified locale.
getMessage() - Method in exception org.apache.commons.math.exception.MathUnsupportedOperationException
Gets the message in a conventional US locale.
getMessage(Locale) - Method in exception org.apache.commons.math.MathException
Gets the message in a specified locale.
getMessage() - Method in exception org.apache.commons.math.MathException
Gets the message in a conventional US locale.
getMessage(Locale) - Method in exception org.apache.commons.math.MathRuntimeException
Gets the message in a specified locale.
getMessage() - Method in exception org.apache.commons.math.MathRuntimeException
Gets the message in a conventional US locale.
getMethod(Class<?>, String, Class[]) - Static method in class umontreal.iro.lecuyer.util.Introspection
This is like getMethod, except that it can return non-public methods.
getMethodBinary() - Method in class flanagan.math.PsRandom
 
getMethodDecimal() - Method in class flanagan.math.PsRandom
 
getMethods(Class<?>) - Static method in class umontreal.iro.lecuyer.util.Introspection
Returns all the methods declared and inherited by a class.
getMFont() - Method in class jhplot.GHMargin
Get the font on this panel
getMicroVersion() - Static method in class cern.colt.Version
Returns the micro version of this release.
getMid() - Method in class org.apache.commons.math.optimization.univariate.BracketFinder
 
getMidTime12() - Method in class flanagan.math.TimeAndDate
 
getMidTime24() - Method in class flanagan.math.TimeAndDate
 
getMilliSecond() - Method in class flanagan.math.TimeAndDate
 
getMin() - Method in class jhplot.F1D
Get the minimum value in X
getMin() - Method in class jhplot.FND
Get the minimum value in X
getMin() - Method in class jhplot.H1D
Get Minimum value of the axis
getMin() - Method in class jhplot.HProf1D
Get Minimum value of the axis
getMin(int) - Method in class jhplot.jadraw.JaAxes
Get min value
getMin() - Method in class jhplot.P0D
Returns the minimum value.
getMin() - Method in class jhplot.P0I
Returns the minimum value.
getMin(int) - Method in class jhplot.P1D
Returns the minimum value in the range.
getMin(int) - Method in class jhplot.P2D
Returns the minimum value in the range.
getMin(int) - Method in class jhplot.P3D
Returns the minimum value in the range.
getMin() - Method in class jhplot.PND
Get max value
getMin() - Method in class jhplot.PNI
Get max value
getMin() - Method in class jminhep.cluster.DataHolder
Get Min values of the data holder
getMin() - Method in exception org.apache.commons.math.exception.NumberIsTooSmallException
 
getMin() - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
 
getMin() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the minimum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMin() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the minimum of the ith entries of the arrays that correspond to each multivariate sample
getMin() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the minimum of the available values
getMin() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getMin() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the minimum of the values that have been added.
getMin() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the minimum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getMin() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the minimum of the values that have been added.
getMinimalIterationCount() - Method in interface org.apache.commons.math.analysis.integration.UnivariateRealIntegrator
Get the lower limit for the number of iterations.
getMinimalIterationCount() - Method in class org.apache.commons.math.analysis.integration.UnivariateRealIntegratorImpl
Get the lower limit for the number of iterations.
getMinImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured minimum implementation.
getMinImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured minimum implementation
getMinImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured minimum implementation
getMinimum() - Method in class flanagan.math.ArrayMaths
 
getMinimum() - Method in class flanagan.math.Minimisation
 
getMinimum_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_byte() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_Byte() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_char() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_Character() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_double() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_Double() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_Float() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_float() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_int() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_Integer() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_long() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_Long() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_short() - Method in class flanagan.math.ArrayMaths
 
getMinimum_as_Short() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_byte() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_Byte() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_double() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_Double() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_float() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_Float() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_int() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_Integer() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_long() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_Long() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_short() - Method in class flanagan.math.ArrayMaths
 
getMinimumDifference_as_Short() - Method in class flanagan.math.ArrayMaths
 
getMinimumIndex() - Method in class flanagan.math.ArrayMaths
 
getMinIndex() - Method in class jhplot.P0D
Returns index corresponding to minimum value.
getMinIndex() - Method in class jhplot.P0I
Returns index corresponding to minimum value.
getMinIndex(int) - Method in class jhplot.P1D
Returns the index of minimum value in the range.
getMinIndex() - Method in class org.apache.commons.math.linear.AbstractRealVector
Get the index of the minimum entry.
getMinKnot() - Method in class umontreal.iro.lecuyer.functionfit.BSpline
Returns the knot minimal value.
getMinLocation() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Return the minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Return the minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Returns minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
getMinLocation() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
getMinLocation() - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Return the minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Return the minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Returns minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
getMinLocation() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
getMinLocation() - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
getMinLocation() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
getMinLocation() - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tint.IntMatrix1D
Return the minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tint.IntMatrix2D
Return the minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tint.IntMatrix3D
Returns minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
getMinLocation() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
getMinLocation() - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
getMinLocation() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Return the minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Return the minimum value of this matrix together with its location
getMinLocation() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Returns minimum value of this matrix together with its location
getMinOrderForSumOfPowers() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns Integer.MIN_VALUE, the minimum order k for which sums of powers are retrievable.
getMinOrderForSumOfPowers() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the minimum order k for which sums of powers are retrievable, as specified upon instance construction.
getMinOrderForSumOfPowers() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns Integer.MIN_VALUE, the minimum order k for which sums of powers are retrievable.
getMinOrderForSumOfPowers() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the minimum order k for which sums of powers are retrievable, as specified upon instance construction.
getMinOrderForSumOfPowers() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns Integer.MIN_VALUE, the minimum order k for which sums of powers are retrievable.
getMinOrderForSumOfPowers() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the minimum order k for which sums of powers are retrievable, as specified upon instance construction.
getMinorVersion() - Static method in class cern.colt.Version
Returns the minor version of this release.
getMinReduction() - Method in class org.apache.commons.math.ode.MultistepIntegrator
Get the minimal reduction factor for stepsize control.
getMinReduction() - Method in class org.apache.commons.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the minimal reduction factor for stepsize control.
getMinStep() - Method in class org.apache.commons.math.ode.nonstiff.AdaptiveStepsizeIntegrator
Get the minimal step.
getMinTest() - Method in class flanagan.analysis.Regression
 
getMinTest() - Method in class flanagan.math.Minimisation
 
getMinute() - Method in class flanagan.math.TimeAndDate
 
getMinutes() - Method in class umontreal.iro.lecuyer.util.AbstractChrono
Returns the CPU time in minutes used by the program since the last call to init for this AbstractChrono.
getMinValue(int) - Method in class jhplot.HPlot
Returns the minimum data value for the specified axis.
getMinValue() - Method in class jhplot.stat.Interpolator
Get maximum value of data in X
getMinValue() - Method in class org.apache.commons.math.linear.AbstractRealVector
Get the value of the minimum entry.
getMinX() - Method in class jhplot.F2D
Get Min value in X
getMinX() - Method in class jhplot.F3D
Get Min value in X
getMinX() - Method in class jhplot.H2D
Get min value of axis in X
getMinX() - Method in class jhplot.HProf2D
Get min value of axis in X
getMinX() - Method in class jhplot.stat.LinReg
Get a minimum value for X
getMinX() - Method in class jhplot.stat.LinRegWeighted
Get a minimum value for X
getMinY() - Method in class jhplot.F2D
Get Min value in Y
getMinY() - Method in class jhplot.F3D
Get Min value in Y
getMinY() - Method in class jhplot.H2D
Get min value of Y axis
getMinY() - Method in class jhplot.HProf2D
Get min value of Y axis
getMinY() - Method in class jhplot.stat.LinReg
Get minimum value for Y
getMinY() - Method in class jhplot.stat.LinRegWeighted
Get minimum value for Y
getMinZ() - Method in class jhplot.F3D
Get Min value in Z
getMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Estimates the parameters p of the Bernoulli distribution using the maximum likelihood method, from the m observations x[i], i = 0, 1,…, m - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Estimates the parameters (α, β) of the beta distribution over the interval [0, 1] using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Estimates the parameter α of the symmetrical beta distribution over the interval [0, 1] using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Estimates the parameters (n, p) of the binomial distribution using the maximum likelihood method, from the m observations x[i], i = 0, 1,…, m - 1.
getMLE(int[], int, int) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Estimates the parameter p of the binomial distribution with given (fixed) parameter n, by the maximum likelihood method, from the m observations x[i], i = 0, 1,…, m - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.CauchyDist
Estimates the parameters (α, β) of the Cauchy distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ChiDist
Estimates the parameter ν of the chi distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Estimates the parameter n of the chi-square distribution using the maximum likelihood method, from the m observations x[i], i = 0, 1,…, m - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ErlangDist
Estimates the parameters (k, λ) of the Erlang distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Estimates the parameter λ of the exponential distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Estimates the parameters (α, λ) of the extreme value distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int, double) - Static method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Estimates the parameters (μ, β, γ) of the fatigue life distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
NOT IMPLEMENTED.
getMLE(double[], int, double) - Static method in class umontreal.iro.lecuyer.probdist.FrechetDist
Given δ = delta, estimates the parameters (α, β) of the Fréchet distribution using the maximum likelihood method with the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Estimates the parameters (α, λ) of the gamma distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.GeometricDist
Estimates the parameter p of the geometric distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Estimates the parameters (β, δ) of the Gumbel distribution, assuming that β > 0, and using the maximum likelihood method with the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Estimates the parameters μ and σ of the half-normal distribution using the maximum likelihood method from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int, double) - Static method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Estimates the parameter σ of the half-normal distribution using the maximum likelihood method from the n observations x[i], i = 0, 1,…, n - 1 and the parameter μ = mu.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Estimates the parameters (μ, σ) of the hyperbolic secant distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Estimates the parameters (α, β) of the inverse gamma distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Estimates the parameters (μ, λ) of the inverse gaussian distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Estimates the parameters (μ, β) of the Laplace distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Estimates the parameter θ of the logarithmic distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.LogisticDist
Estimates the parameters (α, λ) of the logistic distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Estimates the parameters (α, β) of the log-logistic distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.LognormalDist
Estimates the parameters (μ, σ) of the lognormal distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(int[], int, double) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Estimates the parameter p of the negative binomial distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Estimates the parameter (γ, p) of the negative binomial distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Estimates the parameters (μ, σ) of the normal distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
NOT IMPLEMENTED.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ParetoDist
Estimates the parameters (α, β) of the Pareto distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.PascalDist
Estimates the parameter (n, p) of the Pascal distribution using the maximum likelihood method, from the m observations x[i], i = 0, 1,…, m - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Estimates the parameters (α, β) of the Pearson V distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Estimates the parameters (α1, α2, β) of the Pearson VI distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.PoissonDist
Estimates the parameter λ of the Poisson distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int, double, double) - Static method in class umontreal.iro.lecuyer.probdist.PowerDist
Estimates the parameter c of the power distribution from the n observations x[i], i = 0, 1,…, n - 1, using the maximum likelihood method and assuming that a and b are known.
getMLE(double[], int, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Estimates the parameter β of the Rayleigh distribution using the maximum likelihood method, assuming that a is known, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.StudentDist
Estimates the parameter n of the Student t-distribution using the maximum likelihood method, from the m observations x[i], i = 0, 1,…, m - 1.
getMLE(double[], int, double, double) - Static method in class umontreal.iro.lecuyer.probdist.TriangularDist
Estimates the parameter m of the triangular distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.UniformDist
Estimates the parameter (a, b) of the uniform distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(int[], int) - Static method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Estimates the parameters (i, j) of the uniform distribution over integers using the maximum likelihood method, from the n observations x[k], k = 0, 1,…, n - 1.
getMLE(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Estimates the parameters (α, λ) of the Weibull distribution, assuming that δ = 0, using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLE(double[][], int, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
Estimates the parameters [ hat(α_1),…, hat(α_d)] of the Dirichlet distribution using the maximum likelihood method.
getMLE(int[][], int, int, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Estimates and returns the parameters [hat(p_i),...,hat(p_d)] of the multinomial distribution using the maximum likelihood method.
getMLE(int[][], int, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Estimates and returns the parameters [ hat(γ), hat(p_1),..., hat(p_d)] of the negative multinomial distribution using the maximum likelihood method.
getMLE1(int[], int, double) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Estimates the parameter γ of the negative binomial distribution using the maximum likelihood method, from the n observations x[i], i = 0, 1,…, n - 1.
getMLEmin(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Similar to getMLE, but for the case β < 0.
getMLEMu(double[][], int, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Estimates the parameters μ of the multinormal distribution using the maximum likelihood method.
getMLESigma(double[][], int, int) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Estimates the parameters Σ of the multinormal distribution using the maximum likelihood method.
getMode() - Method in class org.apache.commons.math.random.ValueServer
Getter for property mode.
getModel() - Method in class jhplot.HView3D
Get the current model to build a object.
getMomentsEstimate(double[], int) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Estimates and returns the parameter [hat(n)] of the chi-square distribution using the moments method based on the m observations in table x[i], i = 0, 1,…, m - 1.
getMonth() - Method in class flanagan.math.TimeAndDate
 
getMonthAsInteger() - Method in class flanagan.math.TimeAndDate
 
getMonthAsInteger(String) - Method in class flanagan.math.TimeAndDate
 
getMSE() - Method in class jhplot.stat.LinReg
Get MSE value
getMu() - Method in class org.apache.commons.math.random.ValueServer
Getter for property mu.
getMu() - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Returns the parameter μ.
getMu() - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.probdist.NormalDist
Returns the parameter μ.
getMu() - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Returns the parameter μ of this object.
getMu(int) - Method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Returns the i-th component of the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.randvar.FatigueLifeGen
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.randvar.FoldedNormalGen
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.randvar.HalfNormalGen
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.randvar.HyperbolicSecantGen
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.randvar.InverseGaussianGen
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.randvar.LognormalGen
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.randvar.NormalGen
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.randvar.NormalInverseGaussianGen
Returns the parameter μ of this object.
getMu() - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalGen
Returns the mean vector used by this generator.
getMu(int) - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalGen
Returns the i-th component of the mean vector for this generator.
getMu() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Returns the value of μ.
getMu() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcess
Returns the value of the parameter μ.
getMu() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
Returns the value of μ.
getMu() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
Returns the value of the parameter μ.
getMu() - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Returns mu.
getMu1() - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Returns the parameter μ1.
getMu2() - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Returns the parameter μ2.
getMuGeom() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Returns the geometric drift parameter, which is usually the interest rate, r.
getMultipleF() - Method in class flanagan.analysis.Regression
 
getMultiText() - Method in class jhplot.jadraw.JaTextBox
Get multiline text
getMutationPolicy() - Method in class org.apache.commons.math.genetics.GeneticAlgorithm
Returns the mutation policy.
getMutationRate() - Method in class jhplot.HCellular
Returns the mutation rate
getMutationRate() - Method in class org.apache.commons.math.genetics.GeneticAlgorithm
Returns the mutation rate.
getN() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialSplineFunction
Returns the number of spline segments = the number of polynomials = the number of knot points - 1.
getN() - Method in class org.apache.commons.math.stat.correlation.Covariance
Returns the number of observations (length of covariate vectors)
getN() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Get the number of vectors in the sample.
getN() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialMean
Get the number of vectors in the sample.
getN() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.rank.Max
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.rank.Min
Returns the number of values that have been added.
getN() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns the number of available values
getN() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getN() - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.summary.Product
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Returns the number of values that have been added.
getN() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the number of available values
getN() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the number of observations that have been added to the model.
getN() - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
Returns n, the number of observations.
getN() - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.probdist.PascalDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
Returns n, the number of observations.
getN() - Method in class umontreal.iro.lecuyer.probdist.StudentDist
Returns the parameter n associated with this object.
getN() - Method in class umontreal.iro.lecuyer.probdist.WatsonGDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.randvar.BinomialGen
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.randvar.ChiSquareGen
Returns the value of n for this object.
getN() - Method in class umontreal.iro.lecuyer.randvar.FisherFGen
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.randvar.PascalGen
Returns the parameter n of this object.
getN() - Method in class umontreal.iro.lecuyer.randvar.StudentGen
Returns the value of n for this object.
getName() - Method in class hep.aida.ref.event.TreeEvent
 
getName() - Method in class hephysics.particle.LParticle
Get a name
getName() - Method in class jhplot.F1D
Get the name of the function used for evaluation
getName() - Method in class jhplot.F2D
Get the name of the function used for evaluation
getName() - Method in class jhplot.F3D
Get the name of the function used for evaluation
getName() - Method in class jhplot.FND
Get the name of the function used for evaluation
getName() - Method in class jhplot.FPR
Get parametric equation.
getName() - Method in class jhplot.PND
Get a new title
getName(int) - Method in class jminhep.cluster.DataHolder
Get name of the i-th attribute
getName() - Method in class jminhep.cluster.Partition
Get name for this clustering
getName() - Method in class org.apache.commons.math.estimation.EstimatedParameter
Deprecated. get the name of the parameter
getName() - Method in class org.apache.commons.math.ode.AbstractIntegrator
Get the name of the method.
getName() - Method in interface org.apache.commons.math.ode.ODEIntegrator
Get the name of the method.
getName(int) - Method in class umontreal.iro.lecuyer.charts.BoxSeriesCollection
Gets the current name of the selected series.
getName(int) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Gets the current name of the selected series.
getName() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
Returns the name associated to this list, or null if no name was assigned.
getName() - Method in class umontreal.iro.lecuyer.simprocs.Condition
Returns the name (or identifier) associated to this condition.
getName() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Returns the name (or identifier) associated to this resource.
getName() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Returns the global name of this list of statistical probes.
getName() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Returns the name associated with this probe, or null if no name was specified upon construction.
getName() - Method in exception umontreal.iro.lecuyer.util.NameConflictException
Returns the simple name associated with this exception.
getNames() - Method in class jhplot.VHolder
Return Vector with the names
getNameX() - Method in class jhplot.DrawOptions
Get the name of X-axis
getNameY() - Method in class jhplot.DrawOptions
Get the title of Y-axis.
getNameZ() - Method in class jhplot.DrawOptions
Get the title of Z-axis
getNanStrategy() - Method in class org.apache.commons.math.stat.ranking.NaturalRanking
Return the NaNStrategy
getNbObservationTimes() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns the number of observation times excluding the time t0.
getNclusters() - Method in class jminhep.cluster.Partition
get number of reconstructed clusters
getNcol() - Method in class flanagan.math.Matrix
 
getNColumns() - Method in class hephysics.matrix.BasicMatrix
 
getNColumns() - Method in interface hephysics.matrix.Matrix
Returns the number of columns
getNColumns() - Method in class hephysics.matrix.SymmetricMatrix
 
getNColumns() - Method in class hephysics.vec.Hep3Matrix
 
getNegativeValues(IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
getNegativeValues(IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
getNegativeValues(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
getNegativeValues(IntArrayList, IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
getNegativeValues(IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
getNegativeValues(IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
getNegativeValues(IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
getNegativeValues(IntArrayList, IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
getNegativeValues(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
getNegativeValues(IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
getNegativeValues(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
getNegativeValues(IntArrayList, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
getNegativeValues(IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix1D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix2D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix3D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
getNegativeValues(LongArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
getNegativeValues(IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
getNegativeValues(IntArrayList, IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
getNegativeValues(IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Fills the coordinates and values of cells having negative values into the specified lists.
getNegativeValues(IntArrayList, IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Fills the coordinates and values of cells having negative values into the specified lists.
getNEntries() - Method in class jhplot.io.EFile
Get number of events stored in the file.
getNEntries() - Method in class jhplot.io.PFile
Get number of objects stored in the file.
getNentry() - Method in class hep.aida.tdouble.ref.DoubleHistogram1DContents
 
getNentry() - Method in class hep.aida.tfloat.ref.FloatHistogram1DContents
 
getNetwork() - Method in class jhplot.HNeuralNet
Return neural net back.
getNewtonCoefficients() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionNewtonForm
Returns a copy of coefficients in Newton form formula.
getNext() - Method in class org.apache.commons.math.random.ValueServer
Returns the next generated value, generated according to the mode value (see MODE constants).
getNextValue() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Generates a random value from this distribution.
getNextValue() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Generates a random value from this distribution.
getNFM(int) - Method in class jhplot.stat.FactorialMoments
Return results: NFM as a function of number of bins.
getNiter() - Method in class flanagan.analysis.Regression
 
getNiter() - Method in class flanagan.math.Maximisation
 
getNiter() - Method in class flanagan.math.Minimisation
 
getNiterations() - Method in class jhplot.bsom.Bsom
 
getNiterations() - Method in class jhplot.HBsom
Get number of iterations used for fitting
getNKeys() - Method in class jhplot.io.FileRoot
Get number of objects in the current directory of a ROOT file.
getNlrStatus() - Method in class flanagan.analysis.Regression
 
getNmax() - Method in class flanagan.analysis.Regression
 
getNmax() - Method in class flanagan.math.Maximisation
 
getNmax() - Method in class flanagan.math.Minimisation
 
getNMC() - Method in class jhpro.stat.limit.StatConfidence
Get number of MC events
getNMcontract() - Method in class flanagan.analysis.Regression
 
getNMcontract() - Method in class flanagan.math.Maximisation
 
getNMcontract() - Method in class flanagan.math.Minimisation
 
getNMextend() - Method in class flanagan.analysis.Regression
 
getNMextend() - Method in class flanagan.math.Maximisation
 
getNMextend() - Method in class flanagan.math.Minimisation
 
getNMreflect() - Method in class flanagan.analysis.Regression
 
getNMreflect() - Method in class flanagan.math.Maximisation
 
getNMreflect() - Method in class flanagan.math.Minimisation
 
getNobs() - Method in class jhpro.stat.limit.ExpData
Get the number of observations
getNonLinearData() - Static method in class umontreal.iro.lecuyer.rng.F2NL607
Return the data of all the components of the non-linear part of the random number generator.
getNonLinearState() - Method in class umontreal.iro.lecuyer.rng.F2NL607
Returns the current state of the non-linear part of the stream, represented as an array of n integers, where n is the number of components in the non-linear generator.
getNonZeros(IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.DoubleMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, DoubleArrayList, int) - Method in class cern.colt.matrix.DoubleMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.DoubleMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.DoubleMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, ObjectArrayList) - Method in class cern.colt.matrix.ObjectMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, ObjectArrayList) - Method in class cern.colt.matrix.ObjectMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, ObjectArrayList) - Method in class cern.colt.matrix.ObjectMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, ArrayList<double[]>) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, ArrayList<double[]>) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, ArrayList<double[]>) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, ArrayList<double[]>) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
getNonZeros(IntArrayList, ArrayList<double[]>) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
getNonZeros(IntArrayList, IntArrayList, ArrayList<double[]>) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
getNonZeros(IntArrayList, IntArrayList, IntArrayList, ArrayList<double[]>) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
getNonZeros(IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, DoubleArrayList, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Fills the coordinates and values of the first maxCardinality cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
getNonZeros(IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
getNonZeros(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
getNonZeros(IntArrayList, IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
getNonZeros(IntArrayList, ArrayList<float[]>) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, ArrayList<float[]>) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, ArrayList<float[]>) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, ArrayList<float[]>) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
getNonZeros(IntArrayList, ArrayList<float[]>) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
getNonZeros(IntArrayList, IntArrayList, ArrayList<float[]>) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
getNonZeros(IntArrayList, IntArrayList, IntArrayList, ArrayList<float[]>) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
getNonZeros(IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, FloatArrayList, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Fills the coordinates and values of the first maxCardinality cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
getNonZeros(IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
getNonZeros(IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
getNonZeros(IntArrayList, IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
getNonZeros(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
getNonZeros(IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
getNonZeros(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
getNonZeros(IntArrayList, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
getNonZeros(IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Fills the coordinates and values of the first maxCardinality cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
getNonZeros(LongArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
getNonZeros(IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
getNonZeros(IntArrayList, IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
getNonZeros(IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, LongArrayList, int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Fills the coordinates and values of the first maxCardinality cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, ObjectArrayList) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
getNonZeros(IntArrayList, ObjectArrayList) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, ObjectArrayList) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNonZeros(IntArrayList, IntArrayList, IntArrayList, ObjectArrayList) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Fills the coordinates and values of cells having non-zero values into the specified lists.
getNorm() - Method in class org.apache.commons.math.geometry.Vector3D
Get the L2 norm for the vector.
getNorm() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in class org.apache.commons.math.linear.AbstractRealVector
Returns the L2 norm of the vector.
getNorm() - Method in class org.apache.commons.math.linear.ArrayRealVector
Returns the L2 norm of the vector.
getNorm() - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the maximum absolute row sum norm of the matrix.
getNorm() - Method in interface org.apache.commons.math.linear.RealVector
Returns the L2 norm of the vector.
getNorm() - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Returns the L2 norm of the matrix.
getNorm() - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Returns the L2 norm of the matrix.
getNorm1() - Method in class org.apache.commons.math.geometry.Vector3D
Get the L1 norm for the vector.
getNormalGen() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Returns the normal generator.
getNormalizationAmplitude() - Method in class hep.aida.ref.function.BaseModelFunction
 
getNormInf() - Method in class org.apache.commons.math.geometry.Vector3D
Get the L norm for the vector.
getNormSq() - Method in class org.apache.commons.math.geometry.Vector3D
Get the square of the norm for the vector.
getNormType() - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
getNormType() - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Returns the vector-norm in use
getNormType() - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
getNormType() - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Returns the vector-norm in use
getNrestarts() - Method in class flanagan.analysis.Regression
 
getNrestarts() - Method in class flanagan.math.Maximisation
 
getNrestarts() - Method in class flanagan.math.Minimisation
 
getNrestartsMax() - Method in class flanagan.analysis.Regression
 
getNrestartsMax() - Method in class flanagan.math.Maximisation
 
getNrestartsMax() - Method in class flanagan.math.Minimisation
 
getNrow() - Method in class flanagan.math.Matrix
 
getNRows() - Method in class hephysics.matrix.BasicMatrix
 
getNRows() - Method in interface hephysics.matrix.Matrix
Returns the number of rows
getNRows() - Method in class hephysics.matrix.SymmetricMatrix
 
getNRows() - Method in class hephysics.vec.Hep3Matrix
 
getNSteps() - Method in class org.apache.commons.math.ode.nonstiff.AdamsNordsieckTransformer
Get the number of steps of the method (excluding the one being computed).
getNtotX() - Method in class jhplot.GHFrame
Get the total number of graphs in X
getNtotX() - Method in class jhplot.HPlotJa
Get the total number of graphs in X
getNtotY() - Method in class jhplot.GHFrame
Get the total number of the graphs in Y
getNtotY() - Method in class jhplot.HPlotJa
Get the total number of the graphs in Y
getNu() - Method in class umontreal.iro.lecuyer.probdist.ChiDist
Returns the value of ν for this object.
getNu() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Returns the parameter ν of this object.
getNu() - Method in class umontreal.iro.lecuyer.randvar.ChiGen
Returns the value of ν for this object.
getNu() - Method in class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralGen
Returns the value of ν of this object.
getNu() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcess
Returns the value of the parameter ν.
getNu() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
Returns the value of the parameter ν.
getNu() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Returns the value of the parameter ν.
getNumberChennels() - Method in class jhpro.stat.DataSource
Get total numberer of channels
getNumberOfColumns() - Method in class flanagan.math.Matrix
 
getNumberOfDimensions() - Method in class flanagan.interpolation.PolyCubicSpline
 
getNumberOfElements() - Method in interface org.apache.commons.math.distribution.ZipfDistribution
Get the number of elements (e.g.
getNumberOfElements() - Method in class org.apache.commons.math.distribution.ZipfDistributionImpl
Get the number of elements (e.g.
getNumberOfFailures() - Method in class jhplot.math.num.pdf.Hypergeometric
Access the number of failures.
getNumberOfIterations() - Method in class flanagan.integration.RungeKutta
 
getNumberOfJacobiRotations() - Method in class flanagan.math.Matrix
 
getNumberOfPsdPoints() - Method in class flanagan.math.FourierTransform
 
getNumberOfRandomStreams() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
Returns the number of random streams of this process.
getNumberOfRows() - Method in class flanagan.math.Matrix
 
getNumberOfSimulations() - Method in class flanagan.analysis.PCA
 
getNumberOfSuccesses() - Method in class jhplot.math.num.pdf.Hypergeometric
Access the number of successes.
getNumberOfSuccesses() - Method in class jhplot.math.num.pdf.NegativeBinomial
Access the number of successes.
getNumberOfSuccesses() - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Access the number of successes.
getNumberOfSuccesses() - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Access the number of successes.
getNumberOfSuccesses() - Method in interface org.apache.commons.math.distribution.PascalDistribution
Access the number of successes for this distribution.
getNumberOfSuccesses() - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Access the number of successes for this distribution.
getNumberOfTics(int) - Method in class jhplot.HPlot
Returns the number of ticks for the specfied axis.
getNumberOfTrials() - Method in class jhplot.math.num.pdf.Binomial
Access the number of trials.
getNumberOfTrials() - Method in interface org.apache.commons.math.distribution.BinomialDistribution
Access the number of trials for this distribution.
getNumberOfTrials() - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Access the number of trials for this distribution.
getNumCachedValues() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Returns the total number of values cached by this generator.
getNumCachedValues() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Returns the total number of values cached by this random stream.
getNumDataSets() - Method in class jhplot.SPlot
Return the actual number of data sets.
getNumDigits(double) - Method in class jhplot.jadraw.JaAxes
Return the number of digits required to display the given number.
getNumElements() - Method in interface org.apache.commons.math.util.DoubleArray
Returns the number of elements currently in the array.
getNumElements() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns the number of elements currently in the array.
getNumerator() - Method in class org.apache.commons.math.fraction.BigFraction
Access the numerator as a BigInteger.
getNumerator() - Method in class org.apache.commons.math.fraction.Fraction
Access the numerator.
getNumeratorAsInt() - Method in class org.apache.commons.math.fraction.BigFraction
Access the numerator as a int.
getNumeratorAsLong() - Method in class org.apache.commons.math.fraction.BigFraction
Access the numerator as a long.
getNumeratorDegreesOfFreedom() - Method in class jhplot.math.num.pdf.FDistribution
Access the numerator degrees of freedom.
getNumeratorDegreesOfFreedom() - Method in interface org.apache.commons.math.distribution.FDistribution
Access the numerator degrees of freedom.
getNumeratorDegreesOfFreedom() - Method in class org.apache.commons.math.distribution.FDistributionImpl
Access the numerator degrees of freedom.
getNumeratorFormat() - Method in class org.apache.commons.math.fraction.AbstractFormat
Access the numerator format.
getNumericalMean() - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
Returns the mean.
getNumericalMean() - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Returns the mean.
getNumericalMean() - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Returns the mean.
getNumericalMean() - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Returns the mean of the distribution.
getNumericalMean() - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Returns the mean of the distribution.
getNumericalMean() - Method in class org.apache.commons.math.distribution.FDistributionImpl
Returns the mean of the distribution.
getNumericalMean() - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Returns the mean.
getNumericalMean() - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Returns the mean.
getNumericalMean() - Method in class org.apache.commons.math.distribution.TDistributionImpl
Returns the mean.
getNumericalMean() - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Returns the mean of the distribution.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
Returns the variance.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Returns the variance.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Returns the variance.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Returns the variance of the distribution.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Returns the variance of the distribution.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.FDistributionImpl
Returns the variance of the distribution.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Returns the variance.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Returns the variance.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Returns the variance.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Returns the variance.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Returns the variance of the distribution.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.TDistributionImpl
Returns the variance.
getNumericalVariance() - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Returns the variance of the distribution.
getNumGenerations() - Method in class org.apache.commons.math.genetics.FixedGenerationCount
 
getNumPoints() - Method in class umontreal.iro.lecuyer.hups.ContainerPointSet
Returns the number of points of the contained point set.
getNumPoints() - Method in class umontreal.iro.lecuyer.hups.HaltonSequence
 
getNumPoints() - Method in class umontreal.iro.lecuyer.hups.PointSet
Returns the number of points.
getNumRecords() - Method in class jhplot.io.BaseRecordsFile
Returns the number or records in the database.
getNumRecords() - Method in class jhplot.io.RecordsFile
Returns the current number of records in the database.
getNumUnits() - Method in class umontreal.iro.lecuyer.simprocs.UserRecord
Returns the number of units requested or used by the associated process.
getObject() - Method in class hep.aida.ref.ContainerManagedObject
 
getObject(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getObject(String) - Method in class jhplot.io.FileRoot
Get object associated with the key name in the current directory.
getObject(int) - Method in class jhplot.io.FileRoot
Get object associated with the key name in tthe current directory.
getObjectOutputStream() - Method in class jhplot.io.RecordWriter
 
getObs(int) - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
Returns the value of X(i).
getObs(int) - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
Returns the value of X(i).
getObservable() - Method in class hep.aida.ref.event.ObserverAdapter
 
getObservation(int) - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns X(tj) from the current sample path.
getObservations() - Method in class org.apache.commons.math.optimization.fitting.CurveFitter
Get the observed points.
getObservationTimes() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns a reference to the array that contains the observation times (t0,..., td).
getOldPath() - Method in class hep.aida.ref.event.TreeEvent
 
getOmega() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Returns the risk neutral correction.
getOmega() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
Returns the value of the quantity ω defined in.
getOne() - Method in class org.apache.commons.math.complex.ComplexField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math.dfp.Dfp
Get the constant 1.
getOne() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant 1.
getOne() - Method in interface org.apache.commons.math.Field
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math.fraction.BigFractionField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math.fraction.FractionField
Get the multiplicative identity of the field.
getOne() - Method in class org.apache.commons.math.util.BigRealField
Get the multiplicative identity of the field.
getOneWayAnova() - Static method in class org.apache.commons.math.stat.inference.TestUtils
Deprecated. 2.2 will be removed in 3.0
getOptima() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Get all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Get all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Get all the optima found during the last call to optimize.
getOptima() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Get all the optima found during the last call to optimize.
getOptimaValues() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Get all the function values at optima found during the last call to optimize.
getOptions() - Method in class hep.aida.ref.histogram.Cloud
Get the options with which the Cloud was created.
getOptions() - Method in class hep.aida.ref.tree.Tree
 
getOptions() - Method in class hep.aida.ref.tuple.AbstractTuple
 
getOrder() - Method in class org.apache.commons.math.ode.nonstiff.DormandPrince54Integrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math.ode.nonstiff.DormandPrince853Integrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the order of the method.
getOrder() - Method in class org.apache.commons.math.ode.nonstiff.HighamHall54Integrator
Get the order of the method.
getOrder() - Method in class umontreal.iro.lecuyer.probdist.InverseDistFromDensity
Returns the order associated with this object.
getOrder() - Method in class umontreal.iro.lecuyer.randvar.InverseFromDensityGen
Returns the order associated with this object.
getOriginalDataLength() - Method in class flanagan.math.FourierTransform
 
getOriginalPointSet() - Method in class umontreal.iro.lecuyer.hups.ContainerPointSet
Returns the (untransformed) point set inside this container.
getOtherStream() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Returns the otherStream, which is the stream used to choose between the two quadratic roots from the MSH method.
getOutlineWidth(int) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Returns the outline width in pt.
getOutputStream() - Method in class jhplot.io.RecordWriter
 
getOverflow() - Method in class jhplot.H1D
Number of overflow entries
getOverflow() - Method in class jhplot.HProf1D
Number of overflow entries
getOverflowEntriesX() - Method in class jhplot.H2D
Get overflow entries in Y
getOverflowEntriesX() - Method in class jhplot.HProf2D
Get overflow entries in Y
getOverflowEntriesY() - Method in class jhplot.H2D
Get overflow entries in Y
getOverflowEntriesY() - Method in class jhplot.HProf2D
Get overflow entries in Y
getOverflowHeightX() - Method in class jhplot.H2D
Get overflow entries in Y
getOverflowHeightX() - Method in class jhplot.HProf2D
Get overflow entries in Y
getOverflowHeightY() - Method in class jhplot.H2D
Get overflow height in Y
getOverflowHeightY() - Method in class jhplot.HProf2D
Get overflow height in Y
getOverflowlowHeight() - Method in class jhplot.H1D
Overflow height
getOverflowlowHeight() - Method in class jhplot.HProf1D
Overflow height
getOverlapOption() - Method in class flanagan.math.FourierTransform
 
getP() - Method in class jhplot.math.LUDecomposition
Return pivot permutation vector
getP() - Method in interface org.apache.commons.math.linear.FieldLUDecomposition
Returns the P rows permutation matrix.
getP() - Method in class org.apache.commons.math.linear.FieldLUDecompositionImpl
Returns the P rows permutation matrix.
getP() - Method in interface org.apache.commons.math.linear.LUDecomposition
Returns the P rows permutation matrix.
getP() - Method in class org.apache.commons.math.linear.LUDecompositionImpl
Returns the P rows permutation matrix.
getP() - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Returns the parameter p of this object.
getP() - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
Returns the parameter p of this object.
getP() - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
Returns the p associated with this object.
getP() - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Returns the parameter p of this object.
getP() - Method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Returns the parameters (p1,...,pd) of this object.
getP() - Method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Returns the parameters (p1,...,pd) of this object.
getP() - Method in class umontreal.iro.lecuyer.randvar.BernoulliGen
Returns the parameter p of this object.
getP() - Method in class umontreal.iro.lecuyer.randvar.BinomialGen
Returns the parameter p of this object.
getP() - Method in class umontreal.iro.lecuyer.randvar.GeometricGen
Returns the parameter p of this object.
getP() - Method in class umontreal.iro.lecuyer.randvar.NegativeBinomialGen
Returns the parameter p of this object.
getP() - Method in class umontreal.iro.lecuyer.randvar.PascalGen
Returns the parameter p of this object.
getP0D(int) - Method in class jhplot.PND
Return a specific column as an array
getP0I(int) - Method in class jhplot.PNI
Return a specific column as an array
getP1D(int) - Method in class jhplot.HBook
Get P1D object from the index (key)
getP1D(String) - Method in class jhplot.io.FileRoot
Get P1D associated with the key name.
getP1D(int, int) - Method in class jhplot.PND
Return 2 columns as P1D to show as a X-Y plot
getP1D(int, int) - Method in class jhplot.PNI
Return 2 columns as P1D to show as a X-Y plot
getP2D(int, int, int) - Method in class jhplot.PND
Return 3 columns as P2D to show as a X-Y-Z plot
getP2D(int, int, int) - Method in class jhplot.PNI
Return 3 columns as P2D to show as a X-Y-Z plot
getPad() - Method in class jhplot.HPlotJa
Get current pad object
getPad(int, int) - Method in class jhplot.HPlotJa
Get pad characterised by n1 and n2
getPad(int) - Method in class jhplot.jadraw.JaAxes
Get ID of the current pad
getPadHeight() - Method in class jhplot.HPlotJa
Get the height of the current pad in NDC system.
getPadPositionX() - Method in class jhplot.HPlotJa
Get the position of the current pad in X (NDC coordinate)
getPadPositionY() - Method in class jhplot.HPlotJa
Get the position of the current pad in Y (in NDC coordinate)
getPadWidth() - Method in class jhplot.HPlotJa
Get the width of the current pad in NDC system.
getPadX() - Method in class jhplot.jadraw.JaKey
Get pad ID in X
getPadX() - Method in class jhplot.jadraw.JaText
Get pad ID in X
getPadX() - Method in class jhplot.jadraw.JaTextBox
Get pad ID in X
getPadY() - Method in class jhplot.jadraw.JaKey
Get pad ID in Y
getPadY() - Method in class jhplot.jadraw.JaText
Get pad ID in Y
getPadY() - Method in class jhplot.jadraw.JaTextBox
Get pad ID in Y
getPanelSize() - Method in class jhplot.HPlot
Returns the dimensions of the panel used to display the graph.
getPar(String) - Method in class jhplot.HFitter
Get parameter value
getParallelAnalysisPercentileValue() - Method in class flanagan.analysis.PCA
 
getParametersDimension() - Method in interface org.apache.commons.math.ode.jacobians.ODEWithJacobians
Deprecated. Get the number of parameters.
getParametersDimension() - Method in interface org.apache.commons.math.ode.jacobians.ParameterizedODE
Deprecated. Get the number of parameters.
getParams() - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
Return an array containing the parameter n of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Returns an array that contains the parameter p of the current distribution: [p].
getParams() - Method in class umontreal.iro.lecuyer.probdist.BetaDist
Return a table containing parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Return a table containing the parameter of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
Returns a table that contains the parameters (n, p) of the current distribution, in regular order: [n, p].
getParams() - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
Return a table containing parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.ChiDist
Return a table containing parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Returns a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Return an array containing the parameter n of this object.
getParams() - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
Returns a table containing the parameters of the current distribution.
getParams() - Method in interface umontreal.iro.lecuyer.probdist.Distribution
Returns the parameters of the distribution function in the same order as in the constructors.
getParams() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
Return a table containing parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.ErlangDist
Return a table containing parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
Return an array containing the parameters of the current object in regular order: [α, β, δ].
getParams() - Method in class umontreal.iro.lecuyer.probdist.GammaDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.InverseDistFromDensity
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Returns a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
Returns an array containing the parameter n of this object.
getParams() - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
Returns an array containing the parameter n of this object.
getParams() - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.NormalDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Returns a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.PascalDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
Return a table containing parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
Return a table containing the parameter of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.PowerDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
Return an array containing the parameters of the current distribution in the order: [a, β].
getParams() - Method in class umontreal.iro.lecuyer.probdist.StudentDist
Return a table containing the parameter of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.UniformDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Return a table containing the parameters of the current distribution.
getParams() - Method in class umontreal.iro.lecuyer.probdist.WatsonGDist
Return an array containing the parameter n of this object.
getParams() - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
Return an array containing the parameter n of this object.
getParams() - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
Return a table containing the parameters of the current distribution.
getParamValues() - Method in class flanagan.math.Maximisation
 
getParamValues() - Method in class flanagan.math.Minimisation
 
getParent() - Method in class hephysics.particle.LParticle
Get a parent particle
getParse() - Method in class jhplot.F1D
Return parsed function.
getParse() - Method in class jhplot.F2D
Return parsed function.
getParse() - Method in class jhplot.F3D
Return parsed function.
getPartial(EstimatedParameter) - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Deprecated. Get the partial derivative of the theoretical value according to the parameter.
getPath() - Method in class hep.aida.ref.event.TreeEvent
 
getPath() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns a reference to the last generated sample path {X(t0),..., X(td)}.
getPattern() - Method in exception org.apache.commons.math.MathException
Deprecated. as of 2.2 replaced by MathException.getSpecificPattern() and MathException.getGeneralPattern()
getPattern() - Method in exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.getSpecificPattern() and MathRuntimeException.getGeneralPattern()
getPCADecompSigma() - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Returns the matrix A = V()1/2 of this object.
getPct(Object) - Method in class org.apache.commons.math.stat.Frequency
Deprecated. replaced by Frequency.getPct(Comparable) as of 2.0
getPct(Comparable<?>) - Method in class org.apache.commons.math.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(int) - Method in class org.apache.commons.math.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(long) - Method in class org.apache.commons.math.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPct(char) - Method in class org.apache.commons.math.stat.Frequency
Returns the percentage of values that are equal to v (as a proportion between 0 and 1).
getPdgcode() - Method in class hephysics.particle.HEParticle
Get PDG code
getPearsonR() - Method in class jhplot.stat.LinReg
Get pearson R
getPenColor() - Method in class jhplot.P3D
Get the color attribute
getPenWidth() - Method in class jhplot.FPR
Get width of line
getPenWidth() - Method in class jhplot.jadraw.JaKey
Get pen width used to draw the key
getPenWidth() - Method in class jhplot.jadraw.JaLine
Get line width
getPenWidth() - Method in class jhplot.P3D
Get width of the lines
getPenWidthAxes() - Method in class jhplot.HPlot3D
Gets the pen width to draw axes
getPenWidthAxis() - Method in class jhplot.HPlot
Get pen width to draw axis
getPercentile(double) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns an estimate for the pth percentile of the stored values.
getPercentileImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured percentile implementation.
getPhase() - Method in class org.apache.commons.math.optimization.fitting.HarmonicFunction
Get the phase φ.
getPi() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant π.
getPicture() - Method in class jhplot.shapes.Picture
Get the image
getPiSplit() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant π split in two pieces.
getPivot() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns a copy of the pivot permutation vector.
getPivot() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns the pivot permutation vector (not a copy of it).
getPivot() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecomposition
Returns a copy of the pivot permutation vector.
getPivot() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Returns the pivot permutation vector (not a copy of it).
getPivot() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleLUDecomposition
Returns a copy of the pivot permutation vector.
getPivot() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecomposition
Returns a copy of the pivot permutation vector.
getPivot() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Returns the pivot permutation vector (not a copy of it).
getPivot() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatLUDecomposition
Returns a copy of the pivot permutation vector.
getPivot() - Method in interface org.apache.commons.math.linear.FieldLUDecomposition
Returns the pivot permutation vector.
getPivot() - Method in class org.apache.commons.math.linear.FieldLUDecompositionImpl
Returns the pivot permutation vector.
getPivot() - Method in interface org.apache.commons.math.linear.LUDecomposition
Returns the pivot permutation vector.
getPivot() - Method in class org.apache.commons.math.linear.LUDecompositionImpl
Returns the pivot permutation vector.
getPlotCanvas() - Method in class jhplot.HPlot2D
Get the original canvas
getPlotLineOption() - Method in class flanagan.math.FourierTransform
 
getPlotPointOption() - Method in class flanagan.math.FourierTransform
 
getPlotRectangle() - Method in class jhplot.SPlot
Get the current plot rectangle.
getPlotStyle(int) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Gets the current plot style for the selected series.
getPlotType() - Method in class jhplot.jadraw.JaAxes
 
getPoint() - Method in class org.apache.commons.math.optimization.RealPointValuePair
Get the point.
getPoint() - Method in class org.apache.commons.math.optimization.VectorialPointValuePair
Get the point.
getPoint() - Method in class org.apache.commons.math.stat.clustering.EuclideanIntegerPoint
Get the n-dimensional point in integer space.
getPointRef() - Method in class org.apache.commons.math.optimization.RealPointValuePair
Get a reference to the point.
getPointRef() - Method in class org.apache.commons.math.optimization.VectorialPointValuePair
Get a reference to the point.
getPoints() - Method in class jhplot.F1D
Get the number of points
getPoints() - Method in class jhplot.F2D
Get the number of points for evaluation of a function
getPoints() - Method in class jhplot.F3D
Get the number of points for evaluation of a function
getPoints() - Method in class jhplot.FND
Get the number of points
getPoints(DataArray) - Method in class jhplot.jadraw.JaAxes
 
getPoints() - Method in class jminhep.cluster.Partition
Get number of points accosiated with clusters
getPoints() - Method in class org.apache.commons.math.stat.clustering.Cluster
Get the points contained in the cluster.
getPointsNoCuts(DataArray) - Method in class jhplot.jadraw.JaAxes
 
getPolynomialFunction() - Method in class org.apache.commons.math.analysis.solvers.LaguerreSolver
Deprecated. as of 2.0 the function is not stored anymore within the instance.
getPolynomials() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialSplineFunction
Returns a copy of the interpolating polynomials array.
getPopulationLimit() - Method in class org.apache.commons.math.genetics.ListPopulation
Access the maximum population size.
getPopulationLimit() - Method in interface org.apache.commons.math.genetics.Population
Access the maximum population size.
getPopulationSize() - Method in class jhplot.HCellular
Returns the populationSize
getPopulationSize() - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Access the population size.
getPopulationSize() - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Access the population size.
getPopulationSize() - Method in class org.apache.commons.math.genetics.ListPopulation
Access the current population size.
getPopulationSize() - Method in interface org.apache.commons.math.genetics.Population
Access the current population size.
getPortableLibraryName(String) - Static method in class org.netlib.utils.JNIMethods
The System.mapLibraryName method is broken in the sense that it does not give unique names for operating systems and architectures.
getPosition() - Method in class hephysics.particle.HEParticle
Get position in X,Y,Z,time
getPosition() - Method in class jhplot.shapes.HShape
Get position of a primitive
getPositionCoordinate() - Method in class jhplot.HKey
Is the position set?
getPositionCoordinate() - Method in class jhplot.HLabel
Is the position set?
getPositionCoordinate() - Method in class jhplot.HLabelEq
Is the position set?
getPositionCoordinate() - Method in class jhplot.HMLabel
Is the position set?
getPositionCoordinate() - Method in class jhplot.shapes.HShape
Is the position set?
getPositiveValues(IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
getPositiveValues(IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
getPositiveValues(IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
getPositiveValues(IntArrayList, IntArrayList, IntArrayList, DoubleArrayList) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
getPositiveValues(IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
getPositiveValues(IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
getPositiveValues(IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
getPositiveValues(IntArrayList, IntArrayList, IntArrayList, FloatArrayList) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
getPositiveValues(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
getPositiveValues(IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
getPositiveValues(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
getPositiveValues(IntArrayList, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
getPositiveValues(IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix1D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix2D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, IntArrayList, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix3D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
getPositiveValues(LongArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
getPositiveValues(IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
getPositiveValues(IntArrayList, IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
getPositiveValues(IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Fills the coordinates and values of cells having positive values into the specified lists.
getPositiveValues(IntArrayList, IntArrayList, IntArrayList, LongArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Fills the coordinates and values of cells having positive values into the specified lists.
getPosVarCheck() - Method in class flanagan.analysis.Regression
 
getPower() - Method in class umontreal.iro.lecuyer.functions.PowerMathFunction
Returns the power p.
getPowerN(double[], int) - Static method in class jhplot.math.ArrayMathUtils
Sums all components then puts to power n.
getpowerSpectrumEstimate() - Method in class flanagan.math.FourierTransform
 
getPreconditioner() - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterativeSolver
 
getPreconditioner() - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterativeSolver
Gets preconditioner
getPreconditioner() - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterativeSolver
 
getPreconditioner() - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterativeSolver
Gets preconditioner
getPrediction() - Method in class jhplot.stat.LinReg
Get prediction lines
getPrediction(Color) - Method in class jhplot.stat.LinReg
Get prediction lines
getPredictionBand() - Method in class jhplot.stat.LinReg
Calculate the prediction band in form of P1D with errors.
getPredictionBand(Color) - Method in class jhplot.stat.LinReg
Calculate the prediction band in form of P1D with errors.
getPredictionBand(Color, double) - Method in class jhplot.stat.LinReg
Calculate the prediction band in form of P1D with errors.
getPredictionBand(int, Color, double) - Method in class jhplot.stat.LinReg
Calculate the prediction band in form of P1D with errors.
getPreferences() - Static method in class jhplot.HPlotJa
Checks whether preferences have been saved from an earlier session and if yes, imports them.
getPrefix() - Method in class org.apache.commons.math.geometry.Vector3DFormat
Get the format prefix.
getPrefix() - Method in class org.apache.commons.math.linear.RealVectorFormat
Get the format prefix.
getPrevious() - Method in exception org.apache.commons.math.exception.NonMonotonousSequenceException
 
getPreviousTime() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Get the previous grid point time.
getPreviousTime() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Get the previous soft grid point time.
getPreviousTime() - Method in interface org.apache.commons.math.ode.sampling.StepInterpolator
Get the previous grid point time.
getPrimes(int) - Static method in class umontreal.iro.lecuyer.hups.RadicalInverse
Provides an elementary method for obtaining the first n prime numbers larger than 1.
getProb() - Method in class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Returns the chart of the probability.
getProbability() - Method in class jhplot.H1D
Return q probability distribution derived from a histogram.
getProbability() - Method in class jhplot.H2D
Return q probability distribution derived from a histogram.
getProbabilityCH() - Method in class jhpro.stat.limit.StatConfidence
get probability (Cousins+Highland) for the given limit.
getProbabilityJ() - Method in class jhpro.stat.limit.StatConfidence
Probability (Jeffreys) for the given limit.
getProbabilityOfSuccess() - Method in class jhplot.math.num.pdf.Binomial
Access probability of success.
getProbabilityOfSuccess() - Method in class jhplot.math.num.pdf.Geometric
Access probability of success.
getProbabilityOfSuccess() - Method in class jhplot.math.num.pdf.NegativeBinomial
Access probability of success.
getProbabilityOfSuccess() - Method in interface org.apache.commons.math.distribution.BinomialDistribution
Access the probability of success for this distribution.
getProbabilityOfSuccess() - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Access the probability of success for this distribution.
getProbabilityOfSuccess() - Method in interface org.apache.commons.math.distribution.PascalDistribution
Access the probability of success for this distribution.
getProbabilityOfSuccess() - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Access the probability of success for this distribution.
getProbabilitySWG() - Method in class jhpro.stat.limit.StatConfidence
Get probability (BaBar SWG) for the given limit.
getProcess() - Method in class umontreal.iro.lecuyer.simprocs.UserRecord
Returns the process object associated with this record.
getProduct() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_byte() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_Byte() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_Complex() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_double() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_Double() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_float() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_Float() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_int() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_Integer() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_long() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_Long() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_Phasor() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_short() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_Short() - Method in class flanagan.math.ArrayMaths
 
getProduct_as_String() - Method in class flanagan.math.ArrayMaths
 
getProperInstance() - Static method in class org.apache.commons.math.fraction.BigFractionFormat
Returns the default complex format for the current locale.
getProperInstance(Locale) - Static method in class org.apache.commons.math.fraction.BigFractionFormat
Returns the default complex format for the given locale.
getProperInstance() - Static method in class org.apache.commons.math.fraction.FractionFormat
Returns the default complex format for the current locale.
getProperInstance(Locale) - Static method in class org.apache.commons.math.fraction.FractionFormat
Returns the default complex format for the given locale.
getPseudoErrors() - Method in class flanagan.analysis.Regression
 
getPseudoSd() - Method in class flanagan.analysis.Regression
 
getPulsation() - Method in class org.apache.commons.math.optimization.fitting.HarmonicFunction
Get the pulsation ω.
getPvalues() - Method in class flanagan.analysis.Regression
 
getQ() - Method in class cern.colt.matrix.linalg.QRDecomposition
Generates and returns the (economy-sized) orthogonal factor Q.
getQ(boolean) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleQRDecomposition
Generates and returns a copy of the orthogonal factor Q.
getQ() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatQRDecomposition
Generates and returns the (economy-sized) orthogonal factor Q.
getQ() - Method in class jhplot.math.QRDecomposition
Generate and return the (economy-sized) orthogonal factor
getQ() - Method in interface org.apache.commons.math.linear.QRDecomposition
Returns the matrix Q of the decomposition.
getQ() - Method in class org.apache.commons.math.linear.QRDecompositionImpl
Returns the matrix Q of the decomposition.
getQ0() - Method in class org.apache.commons.math.geometry.Rotation
Get the scalar coordinate of the quaternion.
getQ1() - Method in class org.apache.commons.math.geometry.Rotation
Get the first coordinate of the vectorial part of the quaternion.
getQ2() - Method in class org.apache.commons.math.geometry.Rotation
Get the second coordinate of the vectorial part of the quaternion.
getQ3() - Method in class org.apache.commons.math.geometry.Rotation
Get the third coordinate of the vectorial part of the quaternion.
getQT() - Method in interface org.apache.commons.math.linear.QRDecomposition
Returns the transpose of the matrix Q of the decomposition.
getQT() - Method in class org.apache.commons.math.linear.QRDecompositionImpl
Returns the transpose of the matrix Q of the decomposition.
getQuantile() - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Returns the value of the quantile field (determines what percentile is computed when evaluate() is called with no quantile argument).
getQuick(int, int) - Method in class cern.colt.bitvector.BitMatrix
Returns from the receiver the value of the bit at the specified coordinate; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.bitvector.BitVector
Returns from the bitvector the value of the bit with the specified index; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.BooleanArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.ByteArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.CharArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.DistinctNumberList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.DoubleArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.FloatArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.IntArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.LongArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.MinMaxNumberList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.ObjectArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.ShortArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tbyte.ByteArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tchar.CharArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tdouble.DoubleArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tfloat.FloatArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tint.AbstractIntList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tint.IntArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tlong.DistinctNumberList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tlong.LongArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tlong.MinMaxNumberList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tobject.ObjectArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.list.tshort.ShortArrayList
Returns the element at the specified position in the receiver; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.DoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int) - Method in class cern.colt.matrix.ObjectMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.ObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.tbit.BitMatrix
Returns from the receiver the value of the bit at the specified coordinate; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.matrix.tbit.BitVector
Returns from the bitvector the value of the bit with the specified index; WARNING: Does not check preconditions.
getQuick(int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCMDComplexMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCMDComplexMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
getQuick(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseCCMDoubleMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseRCMDoubleMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
getQuick(int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCMFComplexMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCMFComplexMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
getQuick(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseCCMFloatMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseRCMFloatMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tint.impl.DenseLargeIntMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseLargeIntMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tint.impl.SparseCCMIntMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tint.impl.SparseRCMIntMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
getQuick(int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix3D
 
getQuick(int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
getQuick(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseCCMLongMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
getQuick(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseRCMLongMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
getQuick(int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix3D
 
getQuick(int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseCCMObjectMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getQuick(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseRCMObjectMatrix2D
 
getQuick(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
getQuick(int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
getQuick(int, int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
getQuick(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Returns the matrix cell value at coordinate index.
getQuick(int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Returns the matrix cell value at coordinate [row,column].
getQuick(int, int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Returns the matrix cell value at coordinate [slice,row,column].
getR() - Method in class cern.colt.matrix.linalg.QRDecomposition
Returns the upper triangular factor, R.
getR(boolean) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleQRDecomposition
Returns a copy of the upper triangular factor, R.
getR() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleQRDecomposition
Returns a copy of the upper triangular factor, R.
getR() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatQRDecomposition
Returns the upper triangular factor, R.
getR() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatQRDecomposition
Returns a copy of the upper triangular factor, R.
getR() - Method in class jhplot.math.QRDecomposition
Return the upper triangular factor
getR() - Method in interface org.apache.commons.math.linear.QRDecomposition
Returns the matrix R of the decomposition.
getR() - Method in class org.apache.commons.math.linear.QRDecompositionImpl
Returns the matrix R of the decomposition.
getR() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns Pearson's product moment correlation coefficient, usually denoted r.
getRa() - Method in class umontreal.iro.lecuyer.simevents.Event
 
getRadius() - Method in class jhplot.shapes.Circle
Get the radius
getRadiusX() - Method in class jhplot.shapes.Ellipse
Get the radius in X
getRadiusY() - Method in class jhplot.shapes.Ellipse
Get the radius in Y
getRadixDigits() - Method in class org.apache.commons.math.dfp.Dfp
Get the number of radix digits of the instance.
getRadixDigits() - Method in class org.apache.commons.math.dfp.DfpField
Get the number of radix digits of the Dfp instances built by this factory.
getRandomGenerator() - Method in class cern.jet.random.sampling.RandomSamplingAssistant
Returns the used random generator.
getRandomGenerator() - Method in class cern.jet.random.tdouble.sampling.DoubleRandomSamplingAssistant
Returns the used random generator.
getRandomGenerator() - Method in class cern.jet.random.tfloat.sampling.FloatRandomSamplingAssistant
Returns the used random generator.
getRandomGenerator() - Static method in class org.apache.commons.math.genetics.GeneticAlgorithm
Returns the (static) random generator.
getRandomStreamClass() - Method in class umontreal.iro.lecuyer.rng.BasicRandomStreamFactory
Returns the random stream class associated with this object.
getRandomStreamFactory() - Method in exception umontreal.iro.lecuyer.rng.RandomStreamInstantiationException
Returns the random stream factory concerned by this exception.
getRangeBounds() - Method in class umontreal.iro.lecuyer.charts.BoxSeriesCollection
Returns the range (y-coordinates) min and max values.
getRangeBounds() - Method in class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
Returns range (y-coordinates) min and max values.
getRangeBounds() - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Returns range (y-coordinates) min and max values.
getRangeCopy(double[], int, int) - Static method in class jhplot.math.DoubleArray
Extract a section of an array.
getRangeCopy(int[], int, int) - Static method in class jhplot.math.IntegerArray
 
getRangeSet() - Method in class hep.aida.ref.function.BaseModelFunction
 
getRank() - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Return the effective numerical matrix rank.
getRank() - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Return the effective numerical matrix rank.
getRank() - Method in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Get the rank of the covariance matrix.
getRankCorrelation() - Method in class org.apache.commons.math.stat.correlation.SpearmansCorrelation
Returns a PearsonsCorrelation instance constructed from the ranked input data.
getReader() - Method in class jhplot.io.FileRoot
Returns RootFileReader
getReal() - Method in class org.apache.commons.math.complex.Complex
Access the real part.
getRealEigenvalue(int) - Method in interface org.apache.commons.math.linear.EigenDecomposition
Returns the real part of the ith eigenvalue of the original matrix.
getRealEigenvalue(int) - Method in class org.apache.commons.math.linear.EigenDecompositionImpl
Returns the real part of the ith eigenvalue of the original matrix.
getRealEigenvalues() - Method in class cern.colt.matrix.linalg.EigenvalueDecomposition
Returns the real parts of the eigenvalues.
getRealEigenvalues() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleEigenvalueDecomposition
Returns the real parts of the eigenvalues.
getRealEigenvalues() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatEigenvalueDecomposition
Returns the real parts of the eigenvalues.
getRealEigenvalues() - Method in interface org.apache.commons.math.linear.EigenDecomposition
Returns a copy of the real parts of the eigenvalues of the original matrix.
getRealEigenvalues() - Method in class org.apache.commons.math.linear.EigenDecompositionImpl
Returns a copy of the real parts of the eigenvalues of the original matrix.
getRealFormat() - Method in class org.apache.commons.math.complex.ComplexFormat
Access the realFormat.
getRealPart() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns the real part of this matrix
getRealPart() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns the real part of this matrix
getRealPart() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns the real part of this matrix
getRealPart() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
getRealPart() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
getRealPart() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
getRealPart() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
getRealPart() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
getRealPart() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
getRealPart() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
getRealPart() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
getRealPart() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
getRealPart() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
getRealPart() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns the real part of this matrix
getRealPart() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns the real part of this matrix
getRealPart() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns the real part of this matrix
getRealPart() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
getRealPart() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
getRealPart() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
getRealPart() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
getRealPart() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
getRealPart() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
getRealPart() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
getRealPart() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
getRealPart() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
getRealPart() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
getReason() - Method in exception cern.colt.matrix.tdouble.algo.solver.DoubleNotConvergedException
Returns the reason for the exception
getReason() - Method in exception cern.colt.matrix.tfloat.algo.solver.FloatNotConvergedException
Returns the reason for the exception
getRecords() - Method in class jhplot.io.HDataBase
Returns the current number of records in the database.
getReducedChiSquare() - Method in class flanagan.analysis.Regression
 
getReducedFraction(int, int) - Static method in class org.apache.commons.math.fraction.BigFraction
Creates a BigFraction instance with the 2 parts of a fraction Y/Z.
getReducedFraction(int, int) - Static method in class org.apache.commons.math.fraction.Fraction
Creates a Fraction instance with the 2 parts of a fraction Y/Z.
getRegressionSumSquares() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the sum of squared deviations of the predicted y values about their mean (which equals the mean of y).
getRegularizationParameter() - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
Returns the regularization parameter
getRegularizationParameter() - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
Returns the regularization parameter
getRelation() - Method in class jminhep.cluster.DataHolder
Get name of the data holder (i.e.
getRelationship() - Method in class org.apache.commons.math.optimization.linear.LinearConstraint
Get the relationship between left and right hand sides.
getRelativeAccuracy() - Method in interface org.apache.commons.math.ConvergingAlgorithm
Deprecated. Get the actual relative accuracy.
getRelativeAccuracy() - Method in class org.apache.commons.math.ConvergingAlgorithmImpl
Deprecated. Get the actual relative accuracy.
getRelativeAccuracy() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Get the actual relative accuracy.
getRelativeError() - Method in interface jhplot.math.num.IterativeMethod.IterativeState
Access the current relative error in the evaluation.
getRelativeTolerance() - Method in class cern.colt.matrix.tdouble.algo.solver.DefaultDoubleIterationMonitor
Returns the relative convergence tolerance
getRelativeTolerance() - Method in class cern.colt.matrix.tfloat.algo.solver.DefaultFloatIterationMonitor
Returns the relative convergence tolerance
getRelh() - Method in class jhplot.jadraw.JaObject
Returns the relative height of this object.
getRelHndc() - Method in class jhplot.jadraw.JaObject
Returns the relative height of this object in NDC.
getRelHuser() - Method in class jhplot.jadraw.JaObject
Returns the relative height of this object in USER.
getRelSize() - Method in class jhplot.jadraw.JaObject
Returns the relative width and height of this object.
getRelw() - Method in class jhplot.jadraw.JaObject
Returns the relative width of this object.
getRelWndc() - Method in class jhplot.jadraw.JaObject
Returns the relative width of this object in NDC.
getRelWuser() - Method in class jhplot.jadraw.JaObject
Returns the relative width of this object in USER.
getRenderer() - Method in class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
Returns the CategoryItemRenderer object associated with the current object.
getRenderer() - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Returns the XYItemRenderer object associated with the current object.
getRepresentation() - Method in class hephysics.vec.SpacePoint
 
getRequestTime() - Method in class umontreal.iro.lecuyer.simprocs.UserRecord
Returns the time of creation of this record.
getResidual() - Method in exception cern.colt.matrix.tdouble.algo.solver.IterativeSolverDoubleNotConvergedException
Returns final computed residual
getResidual() - Method in exception cern.colt.matrix.tfloat.algo.solver.IterativeSolverFloatNotConvergedException
Returns final computed residual
getResidual() - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Deprecated. Get the residual for this measurement The residual is the measured value minus the theoretical value.
getResiduals() - Method in class flanagan.analysis.Regression
 
getResiduals() - Method in class jhplot.stat.LinReg
Get residuals
getResult() - Method in class jhplot.HBsom
Get results of training.
getResult() - Method in class jhplot.HFitter
Get result of the fit.
getResult() - Method in class jhplot.stat.LinReg
Get the linear regression result
getResult() - Method in class jhplot.stat.LinRegWeighted
Get the fit results
getResult() - Method in interface org.apache.commons.math.analysis.integration.UnivariateRealIntegrator
Get the result of the last run of the integrator.
getResult() - Method in class org.apache.commons.math.analysis.integration.UnivariateRealIntegratorImpl
Access the last computed integral.
getResult() - Method in interface org.apache.commons.math.analysis.solvers.UnivariateRealSolver
Get the result of the last run of the solver.
getResult() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverImpl
Deprecated. Get the result of the last run of the solver.
getResult() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Get the result of the last run of the optimizer.
getResult() - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
Get the result of the last run of the optimizer.
getResult() - Method in interface org.apache.commons.math.optimization.UnivariateRealOptimizer
Get the result of the last run of the optimizer.
getResult() - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.FourthMoment
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.SecondMoment
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
Returns the value of the statistic based on the values that have been added.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Get the covariance matrix.
getResult() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialMean
Get the mean vector.
getResult() - Method in class org.apache.commons.math.stat.descriptive.rank.Max
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.rank.Min
Returns the current value of the Statistic.
getResult() - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.summary.Product
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Returns the current value of the Statistic.
getResult() - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Returns the current value of the Statistic.
getResults(String) - Method in class jhpro.stat.ConfidenceLevel
Display sort of a "canonical" -2lnQ plot.
getResults() - Method in class jhpro.stat.Moments
Get results in form of P1D.
getResults() - Method in class jhpro.stat.MomentsFac
Get results in form of P1D.
getResults() - Method in class jhpro.stat.MomentsFacNorm
Get results in form of P1D.
getResults() - Method in class jhpro.stat.MomentsNorm
Get results in form of P1D.
getRho() - Method in class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Returns the smoothing factor used to construct the spline.
getRms() - Method in class hep.aida.tdouble.ref.DoubleHistogram1DContents
 
getRms() - Method in class hep.aida.tfloat.ref.FloatHistogram1DContents
 
getRMS(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Deprecated. Get the Root Mean Square value.
getRMS(EstimationProblem) - Method in interface org.apache.commons.math.estimation.Estimator
Deprecated. Get the Root Mean Square value.
getRMS() - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Get the Root Mean Square value.
getRmsX() - Method in class jhplot.H2D
Get RMS on X
getRmsX() - Method in class jhplot.HProf2D
Get RMS on X
getRmsY() - Method in class jhplot.H2D
Get RMS on Y
getRmsY() - Method in class jhplot.HProf2D
Get RMS on Y
getRootMatrix() - Method in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Get the root of the covariance matrix.
getRotAngle() - Method in class jhplot.jadraw.JaBlob
Returns the rotation angle of this blob.
getRotAngle() - Method in class jhplot.jadraw.JaKey
Returns the rotAngle property of this text object.
getRotAngle() - Method in class jhplot.jadraw.JaLatexText
Returns the rotAngle property of this text object.
getRotAngle() - Method in class jhplot.jadraw.JaText
Returns the rotAngle property of this text object.
getRotAngle() - Method in class jhplot.jadraw.JaTextBox
Returns the rotAngle property of this text object.
getRotAngle() - Method in class jhplot.jadraw.JaVertexT2
Returns the rotation angle of this vertex.
getRotateTicks(int) - Method in class jhplot.jadraw.JaAxes
Set true if ticks should be rotated
getRotation() - Method in class jhplot.GHMargin
Get the rotation angle of the text in degrees.
getRotation() - Method in class jhplot.HKey
Returns the rotation angle.
getRotation() - Method in class jhplot.HLabel
Returns the rotation angle.
getRotation() - Method in class jhplot.HMLabel
Returns the rotation angle.
getRotation() - Method in class jhplot.shapes.Text
Get the rotation angle
getRotationAngle() - Method in class jhplot.HPlot3D
Get the rotation angle
getRoundingMode() - Method in class org.apache.commons.math.dfp.DfpField
Get the current rounding mode.
getRoundingMode() - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Gets the rounding mode
getRoundingMode() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Gets the rounding mode for division operations The default is BigDecimal.ROUND_HALF_UP
getRoundingMode() - Method in class org.apache.commons.math.util.BigReal
Gets the rounding mode for division operations The default is RoundingMode.HALF_UP
getRow() - Method in class hep.aida.ref.tuple.AbstractTuple
 
getRow() - Method in class hep.aida.ref.tuple.ChainedTuple
Get the current row.
getRow(int) - Method in class jhplot.PND
Return a specific row as array
getRow(int) - Method in class jhplot.PNI
Return a specific row as array
getRow(int) - Method in class jminhep.cluster.DataHolder
Get DataPoint at the position n
getRow(int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the entries in row number row as an array.
getRow(int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the entries in row number row as an array.
getRow(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the entries in row number row as an array.
getRow(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the entries in row number row as an array.
getRow(int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the entries in row number row as an array.
getRow(int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the entries in row number row as an array.
getRow(int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the entries in row number row as an array.
getRow(int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entries in row number row as an array.
getRowAsDoubleArray(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the entries in row number row as an array of double values.
getRowAsDoubleArray(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the entries in row number row as an array of double values.
getRowCompressed() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed(boolean) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed(boolean) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed(boolean) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed(boolean) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressed(boolean) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed form.
getRowCompressedModified() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed modified form.
getRowCompressedModified() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed modified form.
getRowCompressedModified() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed modified form.
getRowCompressedModified() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed modified form.
getRowCompressedModified() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Returns a new matrix that has the same elements as this matrix, but is in a row-compressed modified form.
getRowCopy(int) - Method in class flanagan.math.Matrix
 
getRowCopy(double[][], int) - Static method in class jhplot.math.DoubleArray
Extract a row from a matrix.
getRowCopy(int[][], int) - Static method in class jhplot.math.IntegerArray
 
getRowDimension() - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in interface org.apache.commons.math.linear.AnyMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Returns the number of rows in the matrix.
getRowDimension() - Method in class org.apache.commons.math.linear.SparseFieldMatrix
Returns the number of rows in the matrix.
getRowIndexes() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Returns row indexes;
getRowIndexes() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Returns row indexes;
getRowIndexes() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Returns row indexes;
getRowIndexes() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Returns row indexes;
getRowIndexes() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Returns row indexes;
getRowIndexes() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Returns row indexes;
getRowIndexes() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Returns row indexes;
getRowMajor() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Returns a new matrix that has the same elements as this matrix, but they are addressed internally in row major.
getRowMajor() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Returns a new matrix that has the same elements as this matrix, but they are addressed internally in row major.
getRowMajor() - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
Returns a new matrix that has the same elements as this matrix, but they are addressed internally in row major.
getRowMajor() - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
Returns a new matrix that has the same elements as this matrix, but they are addressed internally in row major.
getRowMajor() - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
Returns a new matrix that has the same elements as this matrix, but they are addressed internally in row major.
getRowMatrix(int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the entries in row number row as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the entries in row number row as a row matrix.
getRowMatrix(int) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the entries in row number row as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the entries in row number row as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the entries in row number row as a row matrix.
getRowMatrix(int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the entries in row number row as a row matrix.
getRowMatrix(int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the entries in row number row as a row matrix.
getRowMatrix(int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entries in row number row as a row matrix.
getRowP0D(int) - Method in class jhplot.PND
Return a specific row as P0D
getRowP0D(int) - Method in class jhplot.PNI
Return a specific row as P0D
getRowPointers() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Returns row pointers
getRowPointers() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Returns row pointers
getRowPointers() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Returns row pointers
getRowPointers() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Returns row pointers
getRowPointers() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Returns row pointers
getRowPointers() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Returns row pointers
getRowPointers() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Returns row pointers
getRows(String, int, int) - Method in class jhplot.PND
Get rows : min is inxluded, max is not;
getRows(String, int, int) - Method in class jhplot.PNI
Get rows : min is inxluded, max is not;
getRowsCopy(double[][], int...) - Static method in class jhplot.math.DoubleArray
Extract specific rows from a matrix.
getRowsCopy(int[][], int...) - Static method in class jhplot.math.IntegerArray
 
getRowsRangeCopy(double[][], int, int) - Static method in class jhplot.math.DoubleArray
Extract a range of rows from a matrix.
getRowsRangeCopy(int[][], int, int) - Static method in class jhplot.math.IntegerArray
 
getRowVector(int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the entries in row number row as a vector.
getRowVector(int) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the entries in row number row as a vector.
getRSquare() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the coefficient of determination, usually denoted r-square.
getRule() - Method in class jhplot.HCellular
Get current rule.
getRules() - Method in class jhplot.HCellular
Get all available rules
getRunNumber() - Method in class jhplot.HCellular
Returns the run number
getS() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the diagonal matrix of singular values.
getS() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleSingularValueDecomposition
Returns the diagonal matrix of singular values.
getS() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatSingularValueDecomposition
Returns the diagonal matrix of singular values.
getS() - Method in class jhplot.math.SingularValueDecomposition
Return the diagonal matrix of singular values
getS() - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Returns the diagonal matrix Σ of the decomposition.
getS() - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Returns the diagonal matrix Σ of the decomposition.
getSafety() - Method in class org.apache.commons.math.ode.MultistepIntegrator
Get the safety factor for stepsize control.
getSafety() - Method in class org.apache.commons.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Get the safety factor for stepsize control.
getSampleMean() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
Returns the sample mean of the observations.
getSampleMean() - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
Returns the sample mean of the observations.
getSampleR() - Method in class flanagan.analysis.Regression
 
getSampleR2() - Method in class flanagan.analysis.Regression
 
getSampleSize() - Method in class jhplot.math.num.pdf.Hypergeometric
Access the sample size.
getSampleSize() - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Access the sample size.
getSampleSize() - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Access the sample size.
getSampleStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
Returns the sample standard deviation of the observations.
getSampleStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
Returns the sample standard deviation of the observations.
getSampleStats() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Returns a StatisticalSummary describing this distribution.
getSampleStats() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Returns a StatisticalSummary describing this distribution.
getSampleVariance() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
Returns the sample variance of the observations.
getSampleVariance() - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
Returns the sample variance of the observations.
getScale() - Method in class flanagan.analysis.Regression
 
getScale() - Method in class flanagan.math.Maximisation
 
getScale() - Method in class flanagan.math.Minimisation
 
getScale() - Method in class jhplot.math.num.pdf.Cauchy
Access the scale parameter.
getScale() - Method in class jhplot.math.num.pdf.Laplace
Access the scale.
getScale() - Method in class jhplot.math.num.pdf.Logistic
Access the scale parameter.
getScale() - Method in class jhplot.math.num.pdf.Rayleigh
Access the scale parameter.
getScale() - Method in class jhplot.math.num.pdf.Weibull
Access the scale parameter.
getScale() - Method in interface org.apache.commons.math.distribution.CauchyDistribution
Access the scale parameter.
getScale() - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Access the scale parameter.
getScale() - Method in interface org.apache.commons.math.distribution.WeibullDistribution
Access the scale parameter.
getScale() - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Access the scale parameter.
getScale() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Sets the scale for division operations.
getScale() - Method in class org.apache.commons.math.util.BigReal
Sets the scale for division operations.
getScaledInitialEstimates() - Method in class flanagan.analysis.Regression
 
getScaledInitialSteps() - Method in class flanagan.analysis.Regression
 
getScaledPosition(double, double) - Method in class jhplot.shapes.HShape
Scale the positions
getScaling() - Method in class jhplot.HPlot3D
Get the scaling
getSecond() - Method in class flanagan.math.TimeAndDate
 
getSecond() - Method in class org.apache.commons.math.genetics.ChromosomePair
Access the second chromosome.
getSecondMoment() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns a statistic related to the Second Central Moment.
getSecondMoment() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns a statistic related to the Second Central Moment.
getSeconds() - Method in class umontreal.iro.lecuyer.util.AbstractChrono
Returns the CPU time in seconds used by the program since the last call to init for this AbstractChrono.
getSeed() - Method in class flanagan.math.PsRandom
 
getSeedAtRowColumn(int, int) - Static method in class cern.jet.random.engine.RandomSeedTable
Returns a deterministic seed from a (seemingly gigantic) matrix of predefined seeds.
getSeedAtRowColumn(int, int) - Static method in class cern.jet.random.tdouble.engine.RandomSeedTable
Returns a deterministic seed from a (seemingly gigantic) matrix of predefined seeds.
getSeeds() - Method in class jminhep.cluster.Partition
Get seeds
getSegmentLength() - Method in class flanagan.math.FourierTransform
 
getSegmentNumber() - Method in class flanagan.math.FourierTransform
 
getSelectionPolicy() - Method in class org.apache.commons.math.genetics.GeneticAlgorithm
Returns the selection policy.
getSensitivity() - Method in class jhpro.stat.limit.StatConfidence
Get sensitivity
getSensitivityError() - Method in class jhpro.stat.limit.StatConfidence
Get error on sensitivity
getSeparator() - Method in class org.apache.commons.math.geometry.Vector3DFormat
Get the format separator between components.
getSeparator() - Method in class org.apache.commons.math.linear.RealVectorFormat
Get the format separator between components.
getSerialVersionUID() - Static method in class flanagan.math.FourierTransform
 
getSerialVersionUID() - Static method in class flanagan.math.PsRandom
 
getSeriesCollection() - Method in class umontreal.iro.lecuyer.charts.BoxChart
Returns the chart's dataset.
getSeriesCollection() - Method in class umontreal.iro.lecuyer.charts.EmpiricalChart
Returns the chart's dataset.
getSeriesCollection() - Method in class umontreal.iro.lecuyer.charts.HistogramChart
Returns the chart's dataset.
getSeriesCollection() - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Returns the CustomHistogramDataset object associated with the current variable.
getSeriesCollection() - Method in class umontreal.iro.lecuyer.charts.ScatterChart
Returns the chart's dataset.
getSeriesCollection() - Method in class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
Returns the CategoryDataset object associated with the current object.
getSeriesCollection() - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Returns the XYDataset object associated with the current object.
getSeriesCollection() - Method in class umontreal.iro.lecuyer.charts.XYLineChart
Returns the chart's dataset.
getSeriesCount() - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the number of series in the dataset.
getSeriesKey(int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the key for a series.
getSettings(XMLWrite) - Method in class jhplot.shapes.HShape
Returns the settings of the primitive in a XML instance.
getShadow() - Method in class jhplot.HPlot
Returns whether or not a shadow will be drawn at the panel border.
getShadowColor() - Method in class jhplot.jadraw.JaTextBox
Get color of shadow
getShadowXOffset() - Method in class jhplot.jadraw.JaTextBox
Get shadow offset in X
getShadowYOffset() - Method in class jhplot.jadraw.JaTextBox
Get shadow offset in Y
getShape() - Method in class jhplot.math.num.pdf.Weibull
Access the shape parameter.
getShape() - Method in interface org.apache.commons.math.distribution.WeibullDistribution
Access the shape parameter.
getShape() - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Access the shape parameter.
getShiftDimension() - Method in class umontreal.iro.lecuyer.hups.RandShiftedPointSet
Returns the number of dimensions of the current random shift.
getShort(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getShortDateUK() - Method in class flanagan.math.TimeAndDate
 
getShortDateUS() - Method in class flanagan.math.TimeAndDate
 
getShortName() - Method in enum umontreal.iro.lecuyer.util.TimeUnit
Returns the short name representing this unit in a string specifying a time duration.
getShortProperty(int) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getShortTime12() - Method in class flanagan.math.TimeAndDate
 
getShortTime24() - Method in class flanagan.math.TimeAndDate
 
getShortTimeNumberOfFrequencies() - Method in class flanagan.math.FourierTransform
 
getShortTimeNumberOfTimes() - Method in class flanagan.math.FourierTransform
 
getShortTimeWindowLength() - Method in class flanagan.math.FourierTransform
 
getSigma() - Method in class org.apache.commons.math.random.ValueServer
Getter for property sigma.
getSigma() - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Returns the parameter σ of this object.
getSigma() - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Returns the parameter σ of this object.
getSigma() - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Returns the parameter σ of this object.
getSigma() - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
Returns the parameter σ of this object.
getSigma() - Method in class umontreal.iro.lecuyer.probdist.NormalDist
Returns the parameter σ.
getSigma() - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
Returns the parameter β.
getSigma() - Method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Returns the parameter Σ of this object.
getSigma() - Method in class umontreal.iro.lecuyer.randvar.FoldedNormalGen
Returns the parameter σ of this object.
getSigma() - Method in class umontreal.iro.lecuyer.randvar.HalfNormalGen
Returns the parameter σ of this object.
getSigma() - Method in class umontreal.iro.lecuyer.randvar.HyperbolicSecantGen
Returns the parameter σ of this object.
getSigma() - Method in class umontreal.iro.lecuyer.randvar.LognormalGen
Returns the parameter σ of this object.
getSigma() - Method in class umontreal.iro.lecuyer.randvar.NormalGen
Returns the parameter σ of this object.
getSigma() - Method in class umontreal.iro.lecuyer.randvar.RayleighGen
Returns the parameter β.
getSigma() - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalGen
Returns the covariance matrix Σ used by this generator.
getSigma() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Returns the value of σ.
getSigma() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
Returns the value of σ.
getSigma() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
Returns the value of σ.
getSigma() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
Returns the value of σ.
getSigma() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
Returns the value of the parameter σ.
getSigma() - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Returns the value of σ.
getSigma() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Returns the value of the parameter σ.
getSigma1() - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Returns the parameter σ1.
getSigma2() - Method in class umontreal.iro.lecuyer.probdistmulti.BiNormalDist
Returns the parameter σ2.
getSignal() - Method in class jhpro.stat.DataSource
Get data for signal
getSignificance() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the significance level of the slope (equiv) correlation.
getSimpleName(Class<?>) - Method in class umontreal.iro.lecuyer.util.ClassFinder
Returns the simple name of the class cls that can be used when the imports contained in this class finder are used.
getSimplexSd() - Method in class flanagan.analysis.Regression
 
getSimplexSd() - Method in class flanagan.math.Maximisation
 
getSimplexSd() - Method in class flanagan.math.Minimisation
 
getSingularValues() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the diagonal of S, which is a one-dimensional array of singular values
getSingularValues() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleSingularValueDecomposition
Returns the diagonal of S, which is a one-dimensional array of singular values
getSingularValues() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatSingularValueDecomposition
Returns the diagonal of S, which is a one-dimensional array of singular values
getSingularValues() - Method in class jhplot.math.SingularValueDecomposition
Return the one-dimensional array of singular values
getSingularValues() - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Returns the diagonal elements of the matrix Σ of the decomposition.
getSingularValues() - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Returns the diagonal elements of the matrix Σ of the decomposition.
getSize() - Method in class jhplot.jadraw.JaObject
Returns the width and height of this object.
getSize() - Method in class jhplot.math.num.DoubleArray
Access the size of this array.
getSize() - Method in class jhpro.stat.DataKeeper
Get the size of container
getSize() - Method in class jminhep.cluster.DataHolder
Get size of the data holder
getSize() - Method in class org.apache.commons.math.util.MultidimensionalCounter
Get the total number of elements.
getSizes() - Method in class org.apache.commons.math.util.MultidimensionalCounter
Get the number of multidimensional counter slots in each dimension.
getSizeX() - Method in class jhplot.GHMargin
Get the size of this margin panel in X
getSizeX() - Method in class jhplot.GHPanel
Get the width of the main panel which keeps all margins and the central panel (in pixels)
getSizeX() - Method in class jhplot.HPlotJa
get X size
getSizeY() - Method in class jhplot.GHMargin
Get the size of this margin in Y
getSizeY() - Method in class jhplot.GHPanel
Get the height of the main panel which keeps all margins and the central panel (in pixels)
getSizeY() - Method in class jhplot.HPlotJa
get Y size
getSkewness() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the skewness of the available values.
getSkewnessImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured skewness implementation.
getSlicesCardinals() - Method in class jhplot.math.Slicing
 
getSlicesCenters() - Method in class jhplot.math.Slicing
 
getSlicesIndexes() - Method in class jhplot.math.Slicing
 
getSlicesWidths() - Method in class jhplot.math.Slicing
 
getSlicingMatrix() - Method in class jhplot.math.Slicing
 
getSlope() - Method in class jhplot.stat.LinReg
Get slope
getSlope() - Method in class jhplot.stat.LinRegWeighted
Get slope
getSlope() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the slope of the estimated regression line.
getSlopeConfidenceInterval() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the half-width of a 95% confidence interval for the slope estimate.
getSlopeConfidenceInterval(double) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the half-width of a (100-100*alpha)% confidence interval for the slope estimate.
getSlopeError() - Method in class jhplot.stat.LinReg
Get the standard error on slope
getSlopeError() - Method in class jhplot.stat.LinRegWeighted
Get the standard error on slope
getSlopeStdErr() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the standard error of the slope estimate, usually denoted s(b1).
getSolver() - Method in interface org.apache.commons.math.linear.CholeskyDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in class org.apache.commons.math.linear.CholeskyDecompositionImpl
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in interface org.apache.commons.math.linear.EigenDecomposition
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in class org.apache.commons.math.linear.EigenDecompositionImpl
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in interface org.apache.commons.math.linear.FieldLUDecomposition
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in class org.apache.commons.math.linear.FieldLUDecompositionImpl
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in interface org.apache.commons.math.linear.LUDecomposition
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in class org.apache.commons.math.linear.LUDecompositionImpl
Get a solver for finding the A × X = B solution in exact linear sense.
getSolver() - Method in interface org.apache.commons.math.linear.QRDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in class org.apache.commons.math.linear.QRDecompositionImpl
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Get a solver for finding the A × X = B solution in least square sense.
getSolver() - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Get a solver for finding the A × X = B solution in least square sense.
getSortedEigenValues() - Method in class flanagan.math.Matrix
 
getSortedEigenvalues() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCA
Returns the sorted eigenvalues obtained in the PCA decomposition.
getSortedEigenvalues() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCAEqualSteps
 
getSortedEigenVector() - Method in class flanagan.math.Matrix
 
getSortedEigenVectorsAsColumns() - Method in class flanagan.math.Matrix
 
getSortedEigenVectorsAsRows() - Method in class flanagan.math.Matrix
 
getSortedValues() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the current set of values in an array of double primitives, sorted in ascending order.
getSource() - Method in interface hep.aida.ref.tuple.FTupleEvent
 
getSourceString() - Method in class org.apache.commons.math.exception.util.DummyLocalizable
Get the source (non-localized) string.
getSourceString() - Method in interface org.apache.commons.math.exception.util.Localizable
Get the source (non-localized) string.
getSourceString() - Method in enum org.apache.commons.math.exception.util.LocalizedFormats
Get the source (non-localized) string.
getSpaceparity() - Method in class hephysics.particle.HEParticle
get P space parity
getSparcity() - Method in class org.apache.commons.math.linear.OpenMapRealVector
Deprecated. as of 2.2 replaced by the correctly spelled OpenMapRealVector.getSparsity()
getSparsity() - Method in class org.apache.commons.math.linear.OpenMapRealVector
 
getSpecificPattern() - Method in exception org.apache.commons.math.exception.MathIllegalArgumentException
Gets the localizable pattern used to build the specific part of the message of this throwable.
getSpecificPattern() - Method in exception org.apache.commons.math.exception.MathIllegalStateException
Gets the localizable pattern used to build the specific part of the message of this throwable.
getSpecificPattern() - Method in interface org.apache.commons.math.exception.MathThrowable
Gets the localizable pattern used to build the specific part of the message of this throwable.
getSpecificPattern() - Method in exception org.apache.commons.math.exception.MathUnsupportedOperationException
Gets the localizable pattern used to build the specific part of the message of this throwable.
getSpecificPattern() - Method in exception org.apache.commons.math.MathException
Gets the localizable pattern used to build the specific part of the message of this throwable.
getSpecificPattern() - Method in exception org.apache.commons.math.MathRuntimeException
Gets the localizable pattern used to build the specific part of the message of this throwable.
getSpin() - Method in class hephysics.particle.HEParticle
Get J total spin
getSplinePolynomials() - Method in class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Returns a table containing all fitting polynomials.
getSqr2() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant √2.
getSqr2Reciprocal() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant √2 / 2.
getSqr2Split() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant √2 split in two pieces.
getSqr3() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant √3.
getSqr3Reciprocal() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant √3 / 3.
getSSE() - Method in class jhplot.stat.LinReg
Get SSE value
getSSR() - Method in class jhplot.stat.LinReg
Ger SSR value
getStandardDeviation() - Method in class jhplot.math.num.pdf.LogNormal
Access the standard deviation.
getStandardDeviation() - Method in class jhplot.math.num.pdf.Normal
Access the standard deviation.
getStandardDeviation() - Method in interface org.apache.commons.math.distribution.NormalDistribution
Access the standard deviation.
getStandardDeviation() - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Access the standard deviation.
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getStandardDeviation() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that correspond to each multivariate sample
getStandardDeviation() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the standard deviation of the values that have been added.
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the standard deviation of the available values.
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the standard deviation of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getStandardDeviation() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the standard deviation of the values that have been added.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
 
getStandardDeviation(double) - Static method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Computes the standard deviation of the Bernoulli distribution with parameter p.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.BetaDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Computes the standard deviation of the beta distribution with parameters α and β, over the interval [0, 1].
getStandardDeviation(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Computes the standard deviation of the beta distribution with parameters α and β, over the interval [a, b].
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
 
getStandardDeviation(double) - Static method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Computes and returns the standard deviation of the symmetrical beta distribution with parameter α.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
 
getStandardDeviation(int, double) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Computes the standard deviation of the Binomial distribution with parameters n and p.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.CauchyDist
Returns since the standard deviation does not exist.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.ChiDist
 
getStandardDeviation(int) - Static method in class umontreal.iro.lecuyer.probdist.ChiDist
Computes and returns the standard deviation of the chi distribution with parameter ν.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
 
getStandardDeviation(int) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Returns the standard deviation of the chi-square distribution with parameter n.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Computes and returns the standard deviation of the noncentral chi-square distribution with parameters ν = nu and λ = lambda.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Returns the standard deviation.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
 
getStandardDeviation(int) - Static method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Returns the standard deviation of the distribution with parameter n.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
Computes the standard deviation of the distribution.
getStandardDeviation() - Method in interface umontreal.iro.lecuyer.probdist.Distribution
Returns the standard deviation of the distribution function.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
 
getStandardDeviation(int, double) - Static method in class umontreal.iro.lecuyer.probdist.ErlangDist
Computes and returns the standard deviation of the Erlang distribution with parameters k and λ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
 
getStandardDeviation(double) - Static method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Computes and returns the standard deviation of the exponential distribution with parameter λ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated.  
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Computes and returns the standard deviation of the extreme value distribution with parameters α and λ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
 
getStandardDeviation(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Computes and returns the standard deviation of the fatigue life distribution with parameters μ, β and γ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
 
getStandardDeviation(int, int) - Static method in class umontreal.iro.lecuyer.probdist.FisherFDist
Computes and returns the standard deviation of the Fisher F distribution with parameters n and m.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Computes the standard deviation of the folded normal distribution with parameters μ and σ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
 
getStandardDeviation(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FrechetDist
Returns the standard deviation of the Fréchet distribution with parameters α, β and δ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.GammaDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Computes and returns the standard deviation of the gamma distribution with parameters α and λ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
 
getStandardDeviation(double) - Static method in class umontreal.iro.lecuyer.probdist.GeometricDist
Computes and returns the standard deviation of the geometric distribution with parameter p.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Returns the standard deviation of the Gumbel distribution with parameters β and δ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Computes the standard deviation of the half-normal distribution with parameters μ and σ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Computes and returns the standard deviation of the hyperbolic secant distribution with parameters μ and σ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
 
getStandardDeviation(int, int, int) - Static method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Computes and returns the standard deviation of the hypergeometric distribution with parameters m, l and k.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Returns the standard deviation of the inverse gamma distribution with shape parameter α and scale parameter β.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Computes and returns the standard deviation of the inverse gaussian distribution with parameters μ and λ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
 
getStandardDeviation(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Computes and returns the standard deviation of the Johnson SU distribution with parameters γ, δ, ξ and λ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Computes and returns the standard deviation of the Laplace distribution with parameters μ and β.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
 
getStandardDeviation(double) - Static method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Computes and returns the standard deviation of the logarithmic distribution with parameter θ = theta.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LogisticDist
Computes and returns the standard deviation of the logistic distribution with parameters α and λ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Computes and returns the standard deviation of the log-logistic distribution with parameters α and β.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LognormalDist
Computes and returns the standard deviation of the lognormal distribution with parameters μ and σ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
 
getStandardDeviation(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Computes the standard deviation of the Nakagami distribution with parameters a, λ and c.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Computes and returns the standard deviation of the negative binomial distribution with parameters γ and p.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.NormalDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Computes and returns the standard deviation σ of the normal distribution with parameters μ and σ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
 
getStandardDeviation(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Computes and returns the standard deviation of the normal inverse gaussian distribution with parameters α, β, μ and δ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ParetoDist
Computes and returns the standard deviation of the Pareto distribution with parameters α and β.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Computes and returns the standard deviation of a Pearson V distribution with shape parameter α and scale parameter β.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
 
getStandardDeviation(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Computes and returns the standard deviation of a Pearson VI distribution with shape parameters α1 and α2, and scale parameter β.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
 
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
 
getStandardDeviation(double) - Static method in class umontreal.iro.lecuyer.probdist.PoissonDist
Computes and returns the standard deviation of the Poisson distribution with parameter λ.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.PowerDist
 
getStandardDeviation(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.PowerDist
Computes and returns the standard deviation of the power distribution with parameters a, b and c.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
 
getStandardDeviation(double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Returns the standard deviation β(2 - π/2)1/2 of the Rayleigh distribution with parameter β.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.StudentDist
 
getStandardDeviation(int) - Static method in class umontreal.iro.lecuyer.probdist.StudentDist
Computes and returns the standard deviation of the Student t-distribution with parameter n.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
 
getStandardDeviation(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.TriangularDist
Computes and returns the standard deviation of the triangular distribution with parameters a, b, m.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Returns the square root of the approximate variance.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.UniformDist
 
getStandardDeviation(double, double) - Static method in class umontreal.iro.lecuyer.probdist.UniformDist
Computes and returns the standard deviation of the uniform distribution with parameters a and b.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
 
getStandardDeviation(int, int) - Static method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Computes and returns the standard deviation of the discrete uniform distribution.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
 
getStandardDeviation(int) - Static method in class umontreal.iro.lecuyer.probdist.WatsonUDist
Returns the standard deviation of the Watson U distribution with parameter n.
getStandardDeviation() - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
 
getStandardDeviation(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Computes and returns the standard deviation of the Weibull distribution with parameters α, λ and δ.
getStangle() - Method in class jhplot.jadraw.JaArcObject
Returns the stangle property of this arc object.
getStarterIntegrator() - Method in class org.apache.commons.math.ode.MultistepIntegrator
Get the starter integrator.
getStartValue() - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
 
getStartX(int, int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the start value for a bin.
getStartY(int, int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the start y-value for a bin (which is the same as the y-value).
getStat() - Method in class jhplot.H1D
Calculate complete statistics for this histogram.
getStat() - Method in class jhplot.P0D
Get complete statistics for this container.
getStat() - Method in class jhplot.P0I
Get complete statistics for this container.
getStat(int) - Method in class jhplot.P1D
Get complete statistics for this container for a given axis.
getStatCollecting() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
Returns true if the list collects statistics about its size and sojourn times of elements, and false otherwise.
getState() - Method in class umontreal.iro.lecuyer.rng.GenF2w32
Returns the current state of the stream, represented as an array of 25 integers.
getState() - Method in class umontreal.iro.lecuyer.rng.LFSR113
Returns the current state of the stream, represented as an array of four integers.
getState() - Method in class umontreal.iro.lecuyer.rng.LFSR258
Returns the current state of the stream, represented as an array of five integers.
getState() - Method in class umontreal.iro.lecuyer.rng.MRG31k3p
Returns the current state Cg of this stream.
getState() - Method in class umontreal.iro.lecuyer.rng.MRG32k3a
Returns the current state Cg of this stream.
getState() - Method in class umontreal.iro.lecuyer.rng.MRG32k3aL
 
getState() - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated. Returns the current state Cg of this stream.
getState() - Method in class umontreal.iro.lecuyer.rng.RandRijndael
Returns the current state of the stream, represented as an array of four integers.
getState() - Method in class umontreal.iro.lecuyer.rng.WELL1024
Returns the current state of the stream, represented as an array of 32 integers.
getState() - Method in class umontreal.iro.lecuyer.rng.WELL512
Returns the current state of the stream, represented as an array of 16 integers.
getState() - Method in class umontreal.iro.lecuyer.rng.WELL607
Returns the current state of the stream, represented as an array of 19 integers.
getState() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Returns the state of the process.
getStatistic() - Method in class jhpro.stat.ConfidenceLevel
 
getStatistics(H1D) - Method in class jhplot.HPlotJa
Get statistics in form of strings
getStatistics(P1D) - Method in class jhplot.HPlotJa
Get strings representing the statistics for the given object
getStatistics() - Method in class jhplot.jadraw.JaAxes
Get strings representing the statistics of the object
getStatParameters() - Method in class jhplot.H1D
Get statistical parameters of a Histogram as a list of strings
getStatString() - Method in class jhplot.P0D
Returns a string representing statistics.
getStatString() - Method in class jhplot.P0I
Get string with all statistics
getStatus() - Method in class hephysics.particle.HEParticle
Status Monte Carlo code
getStd(int) - Method in class jhplot.stat.PCA
Get standard deviations
getStepHandlers() - Method in class org.apache.commons.math.ode.AbstractIntegrator
Get all the step handlers that have been added to the integrator.
getStepHandlers() - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Get all the step handlers that have been added to the integrator.
getStepHandlers() - Method in interface org.apache.commons.math.ode.ODEIntegrator
Get all the step handlers that have been added to the integrator.
getStirlingError(double) - Static method in class jhplot.math.num.pdf.SaddlePoint
Compute the error of Stirling's series at the given value.
getStoppingCondition() - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
Returns the stopping condition
getStoppingCondition() - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
Returns the stopping condition
getStream() - Method in class umontreal.iro.lecuyer.hups.EmptyRandomization
Returns the internal RandomStream.
getStream() - Method in class umontreal.iro.lecuyer.hups.PointSet
Returns the random stream used to generate random shifts.
getStream() - Method in interface umontreal.iro.lecuyer.hups.PointSetRandomization
Returns the internal RandomStream.
getStream() - Method in class umontreal.iro.lecuyer.hups.RandomShift
Returns the internal RandomStream.
getStream() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGen
Returns the RandomStream used by this generator.
getStream() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
 
getStream() - Method in class umontreal.iro.lecuyer.randvar.UnuranContinuous
 
getStream() - Method in class umontreal.iro.lecuyer.randvar.UnuranDiscreteInt
 
getStream() - Method in class umontreal.iro.lecuyer.randvar.UnuranEmpirical
 
getStream() - Method in class umontreal.iro.lecuyer.randvarmulti.RandomMultivariateGen
Returns the RandomStream used by this object.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Returns the random stream of the normal generator.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
Returns the random stream of the noncentral chi-square generator.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
Returns the random stream of the normal generator.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcess
Returns the RandomStream stream.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
Returns the RandomStream for the underlying Brownian motion.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Returns the stream from the underlying Lévy process.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
 
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
 
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessBridge
Only returns a stream if both inner streams are the same.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Only returns a stream if both inner RandomStream's are the same.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessPCA
 
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Only returns the stream if all streams are equal, including the stream(s) in the underlying InverseGaussianProcess.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Returns the random stream of the normal generator.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns the random stream of the underlying generator.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Returns the random stream of the BrownianMotion process, which should be the same as for the GammaProcess.
getStream() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
Returns the RandomStream of the Γ+ process.
getStream2() - Method in class umontreal.iro.lecuyer.randvar.BetaSymmetricalBestGen
Returns stream s2 associated with this object.
getStream2() - Method in class umontreal.iro.lecuyer.randvar.BetaSymmetricalPolarGen
Returns stream s2 associated with this object.
getStream3() - Method in class umontreal.iro.lecuyer.randvar.BetaSymmetricalBestGen
Returns stream s3 associated with this object.
getStreams() - Method in class umontreal.iro.lecuyer.rng.RandomStreamManager
Returns an unmodifiable list containing all the random streams in this random stream manager.
getStrict() - Method in exception org.apache.commons.math.exception.NonMonotonousSequenceException
 
getString(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getString() - Method in class jhplot.GHMargin
Get the title of this panel
getStringPositionX() - Method in class jhplot.GHMargin
Get the text position in X relative to widths
getStringPositionY() - Method in class jhplot.GHMargin
Get the text position in Y relative to the frame height.
getStringProperty(int) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getStringValues() - Method in class jhplot.P0D
Return all values as a string.
getStringValues() - Method in class jhplot.P0I
Return all values as a string.
getStroke() - Method in class jhplot.jadraw.JaArcObject
Returns the stroke property of this arc object.
getStroke() - Method in class jhplot.jadraw.JaFillObject
Returns the stroke (line width) of this object.
getStroke() - Method in class jhplot.jadraw.JaLineObject
Returns the stroke property of this line object.
getStroke() - Method in class jhplot.jadraw.JaLoopObject
Returns the stroke property of this loop object.
getStroke() - Method in class jhplot.jadraw.JaVertex
Returns the stroke property of this line object.
getStroke() - Method in class jhplot.shapes.HShape
Get the Stroke to a specific value
getStyle() - Method in class jhplot.HPlot2D
Get current style
getSubMatrix(int, int, int, int) - Method in class flanagan.math.Matrix
 
getSubMatrix(int[], int[]) - Method in class flanagan.math.Matrix
 
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Gets a submatrix.
getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Gets a submatrix.
getSubMatrix(int[], int[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math.linear.FieldMatrix
Gets a submatrix.
getSubMatrix(int, int, int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Gets a submatrix.
getSubMatrix(int[], int[]) - Method in interface org.apache.commons.math.linear.RealMatrix
Gets a submatrix.
getSubMatrixRangeCopy(double[][], int, int, int, int) - Static method in class jhplot.math.DoubleArray
Carve out a submatrix from the input matrix and return a copy.
getSubMatrixRangeCopy(int[][], int, int, int, int) - Static method in class jhplot.math.IntegerArray
 
getSubpath(double[], int[]) - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns in subpath the values of the process at a subset of the observation times, specified as the times tj whose indices j are in the array pathIndices.
getSubTicksNumber(int) - Method in class jhplot.jadraw.JaAxes
Get the number of sub-ticks
getSubTicksSize(int) - Method in class jhplot.jadraw.JaAxes
Get sub-tick size
getSubTicLength(int) - Method in class jhplot.HPlot
Returns the length of the sub-ticks.
getSubTicNumber(int) - Method in class jhplot.HPlot
Get the number of subticks for a given axis
getSubVector(int, int) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math.linear.ArrayRealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in interface org.apache.commons.math.linear.FieldVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in interface org.apache.commons.math.linear.RealVector
Get a subvector from consecutive elements.
getSubVector(int, int) - Method in class org.apache.commons.math.linear.SparseFieldVector
Get a subvector from consecutive elements.
getSuffix() - Method in class org.apache.commons.math.geometry.Vector3DFormat
Get the format suffix.
getSuffix() - Method in class org.apache.commons.math.linear.RealVectorFormat
Get the format suffix.
getSum() - Method in class flanagan.math.ArrayMaths
 
getSum() - Method in class jhplot.P0D
Returns the sum of all values.
getSum() - Method in class jhplot.P0I
Returns the sum of all values.
getSum() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSum() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the sum of the ith entries of the arrays that correspond to each multivariate sample
getSum() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the sum of the values that have been added to Univariate.
getSum() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getSum() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the sum of the values that have been added
getSum() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the sum of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSum() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the sum of the values that have been added
getSum_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
getSum_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
getSum_as_byte() - Method in class flanagan.math.ArrayMaths
 
getSum_as_Byte() - Method in class flanagan.math.ArrayMaths
 
getSum_as_Complex() - Method in class flanagan.math.ArrayMaths
 
getSum_as_double() - Method in class flanagan.math.ArrayMaths
 
getSum_as_Double() - Method in class flanagan.math.ArrayMaths
 
getSum_as_float() - Method in class flanagan.math.ArrayMaths
 
getSum_as_Float() - Method in class flanagan.math.ArrayMaths
 
getSum_as_int() - Method in class flanagan.math.ArrayMaths
 
getSum_as_Integer() - Method in class flanagan.math.ArrayMaths
 
getSum_as_long() - Method in class flanagan.math.ArrayMaths
 
getSum_as_Long() - Method in class flanagan.math.ArrayMaths
 
getSum_as_Phasor() - Method in class flanagan.math.ArrayMaths
 
getSum_as_short() - Method in class flanagan.math.ArrayMaths
 
getSum_as_Short() - Method in class flanagan.math.ArrayMaths
 
getSum_as_String() - Method in class flanagan.math.ArrayMaths
 
getSumFreq() - Method in class org.apache.commons.math.stat.Frequency
Returns the sum of all frequencies.
getSumImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured sum implementation.
getSumImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured Sum implementation
getSumImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured Sum implementation
getSumLog() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumLog() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that correspond to each multivariate sample
getSumLog() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the sum of logs of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumLogImpl() - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured sum of logs implementation
getSumLogImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured sum of logs implementation
getSummary() - Method in class jhplot.stat.PCA
Return projection vectors and information per projection vector.
getSummary() - Method in class jhplot.stat.StatShape
Return all shape parameters
getSummary() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Return a StatisticalSummaryValues instance reporting current aggregate statistics.
getSummary() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Return a StatisticalSummaryValues instance reporting current statistics.
getSummary() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Return a StatisticalSummaryValues instance reporting current statistics.
getSumOfCrossProducts() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the sum of crossproducts, xi*yi.
getSumOfLogs() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns the sum of the logs of all the aggregated data.
getSumOfLogs() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the sum of the logs of the values that have been added.
getSumOfSquares() - Method in class flanagan.analysis.Regression
 
getSumsq() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns the sum of the squares of all the aggregated data.
getSumsq() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the sum of the squares of the available values.
getSumSq() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumSq() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalMultivariateSummary
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that correspond to each multivariate sample
getSumsq() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the sum of the squares of the values that have been added.
getSumSq() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns an array whose ith entry is the sum of squares of the ith entries of the arrays that have been added using MultivariateSummaryStatistics.addValue(double[])
getSumsq() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the sum of the squares of the values that have been added.
getSumsqImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured sum of squares implementation.
getSumsqImpl() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns the currently configured sum of squares implementation
getSumsqImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured sum of squares implementation
getSumSquaredErrors() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the sum of squared errors (SSE) associated with the regression model.
getSumWeight() - Method in class hep.aida.tdouble.ref.DoubleHistogram1DContents
 
getSumWeight() - Method in class hep.aida.tfloat.ref.FloatHistogram1DContents
 
getSumWeightSquared() - Method in class hep.aida.tdouble.ref.DoubleHistogram1DContents
 
getSumWeightSquared() - Method in class hep.aida.tfloat.ref.FloatHistogram1DContents
 
getSumXSquared() - Method in class jhplot.stat.LinReg
Get sun of the square
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
Returns the lower bound of the support for this distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Returns the lower bound of the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Returns the lower bound of the support for this distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Returns the lower bound of the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Returns the lower bound of the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.FDistributionImpl
Returns the lower bound of the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Returns the upper bound of the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Returns the lower bound for the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Returns the lower bound of the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Returns the lower bound of the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Returns the lower bound of the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.TDistributionImpl
Returns the lower bound of the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Returns the lower bound of the support for the distribution.
getSupportLowerBound() - Method in class org.apache.commons.math.distribution.ZipfDistributionImpl
Returns the lower bound of the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
Returns the upper bound of the support for this distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Returns the upper bound of the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Returns the upper bound of the support for this distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Returns the upper bound for the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Returns the upper bound of the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.FDistributionImpl
Returns the upper bound of the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Returns the upper bound of the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Returns the upper bound for the support of the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Returns the upper bound of the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Returns the upper bound of the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Returns the upper bound of the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.TDistributionImpl
Returns the upper bound of the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Returns the upper bound of the support for the distribution.
getSupportUpperBound() - Method in class org.apache.commons.math.distribution.ZipfDistributionImpl
Returns the upper bound of the support for the distribution.
getSurfaceModel() - Method in class jhplot.HPlot3D
Get current surface
getSwap() - Method in class flanagan.math.Matrix
 
getSxx() - Method in class jhplot.stat.LinReg
Get Sxx value: sumXsquared - sumX * sumX / n
getSymbol() - Method in class jhplot.DrawOptions
Get current symbol
getSymbol(DataArray) - Static method in class jhplot.HPlotJa
 
getSymbolColor() - Method in class jhplot.P2D
Get color attribute
getSymbolicAnalysis() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleCholeskyDecomposition
Returns a copy of the symbolic Cholesky analysis object
getSymbolicAnalysis() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleLUDecomposition
Returns a copy of the symbolic LU analysis object
getSymbolicAnalysis() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleQRDecomposition
Returns a copy of the symbolic QR analysis object
getSymbolicAnalysis() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatCholeskyDecomposition
Returns a copy of the symbolic Cholesky analysis object
getSymbolicAnalysis() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatLUDecomposition
Returns a copy of the symbolic LU analysis object
getSymbolicAnalysis() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatQRDecomposition
Returns a copy of the symbolic QR analysis object
getSymbolSize() - Method in class jhplot.P2D
Get size of the symbols
getSymm() - Method in class jhplot.jadraw.JaLineObject
Returns the symm property of this line object.
getSys(P1D[]) - Method in class jhplot.P1D
Return P1D array which contains 2nd level errors (or systematic errors) evaluated from an array of P1D data holders.
getSyy() - Method in class jhplot.stat.LinReg
Get SYY value: sumYsquared - sumY * sumY / n
getT() - Method in class hephysics.vec.HepLorentzVector
Get time (as t())
getText() - Method in class jhplot.HKey
Get the text of the label.
getText() - Method in class jhplot.HLabel
Get the text of the label.
getText() - Method in class jhplot.HLabelEq
Get the equation text of the label.
getText() - Method in class jhplot.HMLabel
Get text of the label.
getText() - Method in class jhplot.jadraw.JaKey
Returns the textString property of this text object.
getText() - Method in class jhplot.jadraw.JaText
Returns the textString property of this text object.
getText() - Method in class jhplot.jadraw.JaTextBox
Returns the textString property of this text object.
getText() - Method in interface jhplot.math.io.StringPrintable
 
getText() - Method in class jhplot.shapes.Text
Get a string with the text
getTextBottom() - Method in class jhplot.GHPanel
Get the text of bottom margin.
getTextBottomColor() - Method in class jhplot.GHPanel
Get the color of bottom margin for the text.
getTextBottomColorBack() - Method in class jhplot.GHPanel
Get the background color of bottom margin
getTextBottomFont() - Method in class jhplot.GHPanel
Get the font of bottom margin.
getTextLeft() - Method in class jhplot.GHPanel
Get the text of left margin.
getTextLeftColor() - Method in class jhplot.GHPanel
Get the color of bottom margin for the text.
getTextLeftColorBack() - Method in class jhplot.GHPanel
Get the background color of left margin
getTextLeftFont() - Method in class jhplot.GHPanel
Get the font of left margin.
getTextPosBottomX() - Method in class jhplot.GHPanel
Get the text position in X relative to widths for bottom margin
getTextPosBottomY() - Method in class jhplot.GHPanel
Get the text position in Y relative to widths for bottom margin
getTextPosLeftX() - Method in class jhplot.GHPanel
Get the text position in X relative to widths for left margin
getTextPosLeftY() - Method in class jhplot.GHPanel
Get the text position in Y relative to widths for left margin
getTextPosRightX() - Method in class jhplot.GHPanel
Get the text position in X relative to widths for right margin
getTextPosRightY() - Method in class jhplot.GHPanel
Get the text position in Y relative to widths for right margin
getTextPosTopX() - Method in class jhplot.GHPanel
Get the text position in X relative to widths for top margin
getTextPosTopY() - Method in class jhplot.GHPanel
Get the text position in Y relative to widths for top margin
getTextRight() - Method in class jhplot.GHPanel
Get text of right margin.
getTextRightColor() - Method in class jhplot.GHPanel
Get the color of right margin for the text.
getTextRightColorBack() - Method in class jhplot.GHPanel
Get the background color of right margin
getTextRightFont() - Method in class jhplot.GHPanel
Get the font of right margin.
getTextRotationBottom() - Method in class jhplot.GHPanel
Get the text rotation for bottom margin
getTextRotationLeft() - Method in class jhplot.GHPanel
Get the text rotation for left margin
getTextRotationRight() - Method in class jhplot.GHPanel
Get the text rotation for right margin
getTextRotationTop() - Method in class jhplot.GHPanel
Get the text rotation for top margin
getTextString() - Method in class jhplot.jadraw.JaLatexText
Returns the textString property of this text object.
getTextTop() - Method in class jhplot.GHPanel
Get text of top margin (title).
getTextTopColor() - Method in class jhplot.GHPanel
Get the color of top margin for the text.
getTextTopColorBack() - Method in class jhplot.GHPanel
Get the background color of top margin
getTextTopFont() - Method in class jhplot.GHPanel
Get the font of top margin
getTheoreticalValue() - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Deprecated. Get the theoretical value expected for this measurement
getTheta() - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Returns the θ associated with this object.
getTheta() - Method in class umontreal.iro.lecuyer.randvar.LogarithmicGen
Returns the θ associated with this object.
getTheta() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
Returns the value of the parameter θ.
getTheta() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Returns the value of the parameter θ.
getTheta0() - Method in class umontreal.iro.lecuyer.randvar.LogarithmicGen
Returns the θ0 associated with this object.
getTicColor(int) - Method in class jhplot.HPlot
Returns the color used by the labels drawn at each tick.
getTicFont(int) - Method in class jhplot.HPlot
Returns the font used by the labels drawn at each tick.
getTicksNumber(int) - Method in class jhplot.jadraw.JaAxes
Get number of main ticks
getTicksSize(int) - Method in class jhplot.jadraw.JaAxes
Get subtick size
getTicLabel() - Method in class jhplot.jadraw.JaAxes
 
getTicLength(int) - Method in class jhplot.HPlot
Returns the length of the ticks.
getTicsMirror(int) - Method in class jhplot.HPlot
Returns whether or not we should draw ticks on the mirror axis.
getTicsRotate(int) - Method in class jhplot.HPlot
Returns whether or not we should rotate the ticks.
getTiesStrategy() - Method in class org.apache.commons.math.stat.ranking.NaturalRanking
Return the TiesStrategy
getTimeFrequencyMatrix() - Method in class flanagan.math.FourierTransform
 
getTimeInterval(double[], int, int, double) - Static method in class umontreal.iro.lecuyer.util.Misc
Returns the index of the time interval corresponding to time t.
getTitle() - Method in class jhplot.DrawOptions
Get the title of an object
getTitle() - Method in class jhplot.F1D
Get a function title
getTitle() - Method in class jhplot.F2D
Get the title
getTitle() - Method in class jhplot.F3D
Get the title
getTitle() - Method in class jhplot.FND
Get the name of the function used for evaluation Same as getName().
getTitle() - Method in class jhplot.FPR
Get the title
getTitle() - Method in class jhplot.H1D
get Title of the histogram
getTitle() - Method in class jhplot.H2D
Get the title
getTitle() - Method in class jhplot.H3D
get Title of the histogram
getTitle() - Method in class jhplot.HProf1D
get Title of the histogram
getTitle() - Method in class jhplot.io.FileRoot
Get ROOT title
getTitle() - Method in class jhplot.P0D
Get a new title
getTitle() - Method in class jhplot.P0I
Get a new title
getTitle() - Method in class jhplot.P1D
Get a new title
getTitle() - Method in class jhplot.P2D
Get a new title
getTitle() - Method in class jhplot.P3D
Get a new title
getTitle() - Method in class jhplot.PND
Get a new title
getTitle() - Method in class jhplot.PNI
Get a new title
getTitle() - Method in class jhplot.SPlot
Get the title of the graph, or an empty string if there is none.
getTitle() - Method in class jhplot.VHolder
Get title of the container
getTitle() - Method in class jhpro.stat.DataKeeper
 
getTitle() - Method in class umontreal.iro.lecuyer.charts.CategoryChart
Gets the current chart title.
getTitle() - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Gets the current chart title.
getTitle() - Method in class umontreal.iro.lecuyer.charts.XYChart
Gets the current chart title.
getTMax() - Method in class jhplot.HCellular
Returns used t_max
getTolerance() - Method in class flanagan.analysis.Regression
 
getTolerance() - Method in class flanagan.math.Maximisation
 
getTolerance() - Method in class flanagan.math.Minimisation
 
getTorus(String) - Static method in class jhplot.HCellular
 
getTotal(int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the total number of observations for a series.
getTotalSumSquares() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the sum of squared deviations of the y values about their mean.
getTrace() - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTrace() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the trace of the matrix (the sum of the elements on the main diagonal).
getTransformedDataAsAlternate() - Method in class flanagan.math.FourierTransform
 
getTransformedDataAsComplex() - Method in class flanagan.math.FourierTransform
 
getTransformer(Class<?>) - Method in class org.apache.commons.math.util.TransformerMap
Returns the Transformer that is mapped to a class if mapping is not present, this returns null.
getTransparency() - Method in class jhplot.jadraw.JaBlob
Get the transparency of it
getTransparency() - Method in class jhplot.jadraw.JaBox
Get the transparency of it
getTransparency() - Method in class jhplot.jadraw.JaLine
Get the transparency of it
getTransparency() - Method in class jhplot.shapes.HShape
Get the transparency level
getTranspose() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Returns a new matrix that is the transpose of this matrix.
getTranspose() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Returns a new matrix that is the transpose of this matrix.
getTranspose() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Returns a new matrix that is the transpose of this matrix.
getTranspose() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Returns a new matrix that is the transpose of this matrix.
getTranspose() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Returns a new matrix that is the transpose of this matrix.
getTranspose() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Returns a new matrix that is the transpose of this matrix.
getTranspose() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Returns a new matrix that is the transpose of this matrix.
getTranspose() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Returns a new matrix that is the transpose of this matrix.
getTranspose() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Returns a new matrix that is the transpose of this matrix.
getTranspose() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Returns a new matrix that is the transpose of this matrix.
getTrapAccuracy() - Static method in class flanagan.integration.Integration
 
getTrapeziumAccuracy() - Method in class flanagan.integration.Integration
 
getTrapeziumIntervals() - Method in class flanagan.integration.Integration
 
getTrapIntervals() - Static method in class flanagan.integration.Integration
 
getTree() - Method in class hep.aida.ref.tree.MountPoint
 
getTrueFreq() - Method in class flanagan.analysis.Regression
 
getTTest() - Static method in class org.apache.commons.math.stat.inference.TestUtils
Deprecated. 2.2 will be removed in 3.0
getTuple(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
getTuple() - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getTvalues() - Method in class flanagan.analysis.Regression
 
getTwinAxisPosition() - Method in class umontreal.iro.lecuyer.charts.Axis
Returns the drawing position parameter (default equals 0).
getTwo() - Method in class org.apache.commons.math.dfp.Dfp
Get the constant 2.
getTwo() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant 2.
getType() - Method in class hep.aida.ref.event.TreeEvent
 
getType() - Method in class hephysics.particle.HEParticle
Get PDG type ID
getType() - Method in class jhplot.DrawOptions
Get the type of the object
getType() - Method in class jhplot.io.csv.bean.HeaderColumnNameMappingStrategy
 
getType() - Method in class jhplot.jadraw.JaKey
Get type of this object
getType() - Method in class jhplot.jadraw.JaText
Get identification type for this label
getType() - Method in class jhplot.jadraw.JaTextBox
Get identification number for this text object
getType() - Method in class jhplot.shapes.Arrow
Get the type of arrow
getType() - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the histogram type.
getTypeName(String) - Method in class hep.aida.ref.function.JELCompiledExpression.Resolver
 
getTypeName(String) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
getU() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns the upper triangular factor, U.
getU() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns the upper triangular factor, U.
getU() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the left singular vectors U.
getU() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecomposition
Returns the upper triangular factor, U.
getU() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Returns the upper triangular factor, U.
getU() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleSingularValueDecomposition
Returns the left singular vectors U.
getU() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleLUDecomposition
Returns the upper triangular factor, U.
getU() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecomposition
Returns the upper triangular factor, U.
getU() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Returns the upper triangular factor, U.
getU() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatSingularValueDecomposition
Returns the left singular vectors U.
getU() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatLUDecomposition
Returns the upper triangular factor, U.
getU() - Method in class jhplot.math.LUDecomposition
Return upper triangular factor
getU() - Method in class jhplot.math.SingularValueDecomposition
Return the left singular vectors
getU() - Method in interface org.apache.commons.math.linear.FieldLUDecomposition
Returns the matrix U of the decomposition.
getU() - Method in class org.apache.commons.math.linear.FieldLUDecompositionImpl
Returns the matrix U of the decomposition.
getU() - Method in interface org.apache.commons.math.linear.LUDecomposition
Returns the matrix U of the decomposition.
getU() - Method in class org.apache.commons.math.linear.LUDecompositionImpl
Returns the matrix U of the decomposition.
getU() - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Returns the matrix U of the decomposition.
getU() - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Returns the matrix U of the decomposition.
getUnboundParameters() - Method in interface org.apache.commons.math.estimation.EstimationProblem
Deprecated. Get the unbound parameters of the problem.
getUnboundParameters() - Method in class org.apache.commons.math.estimation.SimpleEstimationProblem
Deprecated. Get the unbound parameters of the problem.
getUnderflow() - Method in class jhplot.H1D
Number of underflow entries
getUnderflow() - Method in class jhplot.HProf1D
Number of underflow entries
getUnderflowEntriesX() - Method in class jhplot.H2D
Get underflow entries in X
getUnderflowEntriesX() - Method in class jhplot.HProf2D
Get underflow entries in X
getUnderflowEntriesY() - Method in class jhplot.H2D
Get underflow entries in Y
getUnderflowEntriesY() - Method in class jhplot.HProf2D
Get underflow entries in Y
getUnderflowHeight() - Method in class jhplot.H1D
Underflow height
getUnderflowHeight() - Method in class jhplot.HProf1D
Underflow height
getUnderflowHeightsX() - Method in class jhplot.HProf2D
Get underflow heights in X
getUnderflowHeightX() - Method in class jhplot.H2D
Get underflow height in X
getUnderflowHeightX() - Method in class jhplot.HProf2D
Get underflow height in X
getUnderflowHeightY() - Method in class jhplot.H2D
Get underflow height in Y
getUnderflowHeightY() - Method in class jhplot.HProf2D
Get underflow height in Y
getUniqueCount() - Method in class org.apache.commons.math.stat.Frequency
Returns the number of values in the frequency table.
getUnknownDistributionChiSquareTest() - Static method in class org.apache.commons.math.stat.inference.TestUtils
Deprecated. 2.2 will be removed in 3.0
getUpper() - Method in class jhplot.math.num.pdf.Uniform
Access the upper parameter.
getUpperBounds() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Returns the array of upper bounds for the bins.
getUpperBounds() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Returns a fresh copy of the array of upper bounds for the bins.
getUpperEdgeX(int) - Method in class jhplot.H2D
Get upper edge of the bin in X
getUpperEdgeX(int) - Method in class jhplot.HProf2D
Get upper edge of the bin in X
getUpperEdgeY(int) - Method in class jhplot.H2D
Get upper edge of the bin in Y
getUpperEdgeY(int) - Method in class jhplot.HProf2D
Get upper edge of the bin in Y
getUsedDataLength() - Method in class flanagan.math.FourierTransform
 
getUserModeString() - Method in class jhplot.HCellular
 
getUT() - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Returns the transpose of the matrix U of the decomposition.
getUT() - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Returns the transpose of the matrix U of the decomposition.
getV() - Method in class cern.colt.matrix.linalg.EigenvalueDecomposition
Returns the eigenvector matrix, V
getV() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the right singular vectors V.
getV() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleEigenvalueDecomposition
Returns the eigenvector matrix, V
getV() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleSingularValueDecomposition
Returns the right singular vectors V.
getV() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleQRDecomposition
Returns a copy of the Householder vectors v, from the Householder reflections H = I - beta*v*v'.
getV() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatEigenvalueDecomposition
Returns the eigenvector matrix, V
getV() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatSingularValueDecomposition
Returns the right singular vectors V.
getV() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatQRDecomposition
Returns a copy of the Householder vectors v, from the Householder reflections H = I - beta*v*v'.
getV() - Method in class jhplot.math.SingularValueDecomposition
Return the right singular vectors
getV() - Method in interface org.apache.commons.math.linear.EigenDecomposition
Returns the matrix V of the decomposition.
getV() - Method in class org.apache.commons.math.linear.EigenDecompositionImpl
Returns the matrix V of the decomposition.
getV() - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Returns the matrix V of the decomposition.
getV() - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Returns the matrix V of the decomposition.
getV3() - Method in class hephysics.particle.LParticle
Get a 3-vector woth (Px,Py,Pz) or (X,Y,Z)
getV3() - Method in class hephysics.vec.HepLorentzVector
Get 3-vector
getVal() - Method in class jhplot.math.ValueErr
Get current value
getValue() - Method in class flanagan.analysis.ErrorProp
 
getValue(int) - Method in class jhpro.stat.DataKeeper
Get value at index
getValue() - Method in class org.apache.commons.math.linear.RealVector.Entry
Get the value of the entry.
getValue() - Method in class org.apache.commons.math.optimization.linear.LinearConstraint
Get the value of the constraint (right hand side).
getValue(double[]) - Method in class org.apache.commons.math.optimization.linear.LinearObjectiveFunction
Compute the value of the linear equation at the current point
getValue(RealVector) - Method in class org.apache.commons.math.optimization.linear.LinearObjectiveFunction
Compute the value of the linear equation at the current point
getValue() - Method in class org.apache.commons.math.optimization.RealPointValuePair
Get the value of the objective function.
getValue() - Method in class org.apache.commons.math.optimization.VectorialPointValuePair
Get the value of the objective function.
getValue(int, int) - Method in class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
Returns the y-value at the specified index in the specified series.
getValueAt(int, int) - Method in class jhplot.SPsheet
This method returns the cell object at those coordinates.
getValueRef() - Method in class org.apache.commons.math.optimization.VectorialPointValuePair
Get a reference to the value of the objective function.
getValues() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Returns numerical values
getValues() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Returns numerical values
getValues(int) - Method in class jhplot.H1D
Get positions in X,Y and Errors.
getValues(int) - Method in class jhplot.HProf1D
Get positions in X,Y and Errors.
getValues() - Method in class jhpro.stat.DataKeeper
Get values
getValues() - Method in class jhpro.stat.Moments
Get values of the moments
getValues() - Method in class jhpro.stat.MomentsFac
Get values of the factorial moments
getValues() - Method in class jhpro.stat.MomentsFacNorm
Get values of the normalised factorial moments (NFM).
getValues() - Method in class jhpro.stat.MomentsNorm
Get values of the normalised factorial moments (NFM).
getValues() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the current set of values in an array of double primitives.
getValues() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the current set of values in an array of double primitives.
getValues() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Deprecated. replaced by ResizableDoubleArray.getInternalValues() as of 2.0
getValues(int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the values for a series.
getValues(int) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Returns the values for a series.
getValuesFileURL() - Method in class org.apache.commons.math.random.ValueServer
Getter for valuesFileURL
getValuesList(int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the values for a series.
getValuesList(int) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Returns the values for a series.
getVariance() - Method in class jhplot.math.num.pdf.NegativeBinomial
Get mean value.
getVariance() - Method in class org.apache.commons.math.stat.descriptive.AggregateSummaryStatistics
Returns the variance of the available values.
getVariance() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the variance of the available values.
getVariance() - Method in interface org.apache.commons.math.stat.descriptive.StatisticalSummary
Returns the variance of the available values.
getVariance() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
 
getVariance() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the variance of the values that have been added.
getVariance() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the variance of the values that have been added.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
 
getVariance(double) - Static method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Computes the variance Var[X] = p(1 - p) of the Bernoulli distribution with parameter p.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.BetaDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
.
getVariance(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
 
getVariance(double) - Static method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Computes and returns the variance, Var[X] = 1/(8α + 4), of the symmetrical beta distribution with parameter α.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
 
getVariance(int, double) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Computes the variance Var[X] = np(1 - p) of the binomial distribution with parameters n and p.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.CauchyDist
Returns since the variance does not exist.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.ChiDist
 
getVariance(int) - Static method in class umontreal.iro.lecuyer.probdist.ChiDist
Computes and returns the variance of the chi distribution with parameter ν.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
 
getVariance(int) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Returns the variance Var[X] = 2n of the chi-square distribution with parameter n.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Computes and returns the variance Var[X] = 2(ν +2λ) of the noncentral chi-square distribution with parameters ν = nu and λ = lambda.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Returns the variance.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
 
getVariance(int) - Static method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Returns the variance of the distribution with parameter n.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
Computes the variance Var[X] = ∑i=1npi(xi - E[X])2 of the distribution.
getVariance() - Method in interface umontreal.iro.lecuyer.probdist.Distribution
Returns the variance of the distribution function.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
 
getVariance(int, double) - Static method in class umontreal.iro.lecuyer.probdist.ErlangDist
Computes and returns the variance, Var[X] = k/λ2, of the Erlang distribution with parameters k and λ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
 
getVariance(double) - Static method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Computes and returns the variance, Var[X] = 1/λ2, of the exponential distribution with parameter λ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated.  
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Computes and returns the variance, Var[X] = π2/(6λ2), of the extreme value distribution with parameters α and λ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
 
getVariance(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Computes and returns the variance Var[X] = β2γ2(1 + 5γ2/4) of the fatigue life distribution with parameters μ, β and γ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
 
getVariance(int, int) - Static method in class umontreal.iro.lecuyer.probdist.FisherFDist
Computes and returns the variance of the Fisher F distribution with parameters n and m.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
 
getVariance(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FrechetDist
Returns the variance of the Fréchet distribution with parameters α, β and δ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.GammaDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Computes and returns the variance Var[X] = α/λ2 of the gamma distribution with parameters α and λ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
 
getVariance(double) - Static method in class umontreal.iro.lecuyer.probdist.GeometricDist
Computes and returns the variance Var[X] = (1 - p)/p2 of the geometric distribution with parameter p.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Returns the variance Var[X] = π2β2/6 of the Gumbel distribution with parameters β and δ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Computes and returns the variance Var[X] = (1 - 2/π)σ2.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Computes and returns the variance Var[X] = σ2 of the hyperbolic secant distribution with parameters μ and σ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
 
getVariance(int, int, int) - Static method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Computes and returns the variance of the hypergeometric distribution with parameters m, l and k.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Returns the variance Var[X] = β2/((α -1)2(α - 2)) of the inverse gamma distribution with shape parameter α and scale parameter β.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Computes and returns the variance Var[X] = μ3/λ of the inverse gaussian distribution with parameters μ and λ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
 
getVariance(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Computes and returns the variance of the Johnson SU distribution with parameters γ, δ, ξ and λ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Computes and returns the variance Var[X] = 2β2 of the Laplace distribution with parameters μ and β.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
 
getVariance(double) - Static method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Computes and returns the variance of the logarithmic distribution with parameter θ = theta.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LogisticDist
Computes and returns the variance Var[X] = π2/(3λ2) of the logistic distribution with parameters α and λ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Computes and returns the variance of the log-logistic distribution with parameters α and β.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LognormalDist
Computes and returns the variance Var[X] = e2μ+σ2(eσ2 - 1) of the lognormal distribution with parameters μ and σ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
 
getVariance(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NakagamiDist
.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Computes and returns the variance Var[X] = γ(1 - p)/p2 of the negative binomial distribution with parameters γ and p.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.NormalDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Computes and returns the variance Var[X] = σ2 of the normal distribution with parameters μ and σ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
 
getVariance(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Computes and returns the variance Var[X] = δα2/γ3 of the normal inverse gaussian distribution with parameters α, β, μ and δ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ParetoDist
Computes and returns the variance of the Pareto distribution with parameters α and β.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Computes and returns the variance Var[X] = β2/((α -1)2(α - 2) of a Pearson V distribution with shape parameter α and scale parameter β.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
 
getVariance(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Computes and returns the variance Var[X] = [β2α1(α1 + α2 -1)]/[(α2 -1)2(α2 - 2)] of a Pearson VI distribution with shape parameters α1 and α2, and scale parameter β.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
 
getVariance() - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
 
getVariance(double) - Static method in class umontreal.iro.lecuyer.probdist.PoissonDist
Computes and returns the variance = λ of the Poisson distribution with parameter λ.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.PowerDist
 
getVariance(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.PowerDist
Computes and returns the variance (b - a)2c/[(c + 1)2(c + 2)] of the power distribution with parameters a, b and c.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
 
getVariance(double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Returns the variance of the Rayleigh distribution with parameter β.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.StudentDist
 
getVariance(int) - Static method in class umontreal.iro.lecuyer.probdist.StudentDist
Computes and returns the variance Var[X] = n/(n - 2) of the Student t-distribution with parameter n.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
 
getVariance(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.TriangularDist
Computes and returns the variance Var[X] = (a2 + b2 + m2 - ab - am - bm)/18 of the triangular distribution with parameters a, b, m.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Returns an approximation of the variance computed with the Simpson 1/3 numerical integration rule.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.UniformDist
 
getVariance(double, double) - Static method in class umontreal.iro.lecuyer.probdist.UniformDist
Computes and returns the variance Var[X] = (b - a)2/12 of the uniform distribution with parameters a and b.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
 
getVariance(int, int) - Static method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Computes and returns the variance Var[X] = [(j - i + 1)2 -1]/12 of the discrete uniform distribution.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
 
getVariance(int) - Static method in class umontreal.iro.lecuyer.probdist.WatsonUDist
Returns the variance of the Watson U distribution with parameter n.
getVariance() - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
 
getVariance(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Computes and returns the variance of the Weibull distribution with parameters α, λ and δ.
getVarianceDirection() - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Returns the varianceDirection property.
getVarianceGammaProcess() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
Returns a reference to the variance gamma process X defined in the constructor.
getVarianceImpl() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the currently configured variance implementation.
getVarianceImpl() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns the currently configured variance implementation
getVarianceImpl() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns the currently configured variance implementation
getVarianceMax() - Method in class jhpro.stat.EEcentricity
Get variance alone the major axis (longest component)
getVarianceMin() - Method in class jhpro.stat.EEcentricity
Get variance alone the minor (shortest component)
getVarimaxIterations() - Method in class flanagan.analysis.PCA
 
getVarimaxOption() - Method in class flanagan.analysis.PCA
 
getVars() - Method in class jhplot.FND
Return all variables
getVarString() - Method in class jhplot.FND
Get arguments of the function (independent variables).
getVersion() - Method in class jhplot.io.EFile
Get version of the input file.
getVersion() - Method in class jhplot.io.FileRoot
Get ROOT version
getVersion() - Method in class jhplot.io.PFile
Get version of the input file.
getVersion() - Static method in class jhplot.JHPlot
Get version information
getVT() - Method in interface org.apache.commons.math.linear.EigenDecomposition
Returns the transpose of the matrix V of the decomposition.
getVT() - Method in class org.apache.commons.math.linear.EigenDecompositionImpl
Returns the transpose of the matrix V of the decomposition.
getVT() - Method in interface org.apache.commons.math.linear.SingularValueDecomposition
Returns the transpose of the matrix V of the decomposition.
getVT() - Method in class org.apache.commons.math.linear.SingularValueDecompositionImpl
Returns the transpose of the matrix V of the decomposition.
getWeight() - Method in class cern.jet.random.sampling.WeightedRandomSampler
Not yet commented.
getWeight() - Method in class cern.jet.random.tdouble.sampling.WeightedDoubleRandomSampler
 
getWeight() - Method in class cern.jet.random.tfloat.sampling.WeightedFloatRandomSampler
 
getWeight() - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Deprecated. Get the weight of the measurement in the least squares problem
getWeight() - Method in class org.apache.commons.math.optimization.fitting.WeightedObservedPoint
Get the weight of the measurement in the fitting process.
getWeightedResiduals() - Method in class flanagan.analysis.Regression
 
getWeightingOption() - Method in class flanagan.analysis.ProbabilityPlot
 
getWeights() - Method in class flanagan.math.FourierTransform
 
getWeights() - Method in class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Returns the weights of the points.
getWhoAm() - Method in class jhplot.shapes.HShape
Primitive type
getWholeFormat() - Method in class org.apache.commons.math.fraction.ProperBigFractionFormat
Access the whole format.
getWholeFormat() - Method in class org.apache.commons.math.fraction.ProperFractionFormat
Access the whole format.
getWidth() - Method in class jhplot.jadraw.JaObject
Returns the width of this object.
getWidth() - Method in class jhplot.v3d.Model3d
 
getWindowOption() - Method in class flanagan.math.FourierTransform
 
getWindowSize() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Returns the maximum number of values that can be stored in the dataset, or INFINITE_WINDOW (-1) if there is no limit.
getWindowSize() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Returns the maximum number of values that can be stored in the dataset, or INFINITE_WINDOW (-1) if there is no limit.
getX(int) - Method in class jhplot.F1D
Get value in X-axis
getX(int) - Method in class jhplot.FND
Get value in X-axis
getX() - Method in class jhplot.HKey
Returns the X position of the text.
getX() - Method in class jhplot.HLabel
Returns the X position of the text.
getX() - Method in class jhplot.HLabelEq
Returns the X position of the text.
getX() - Method in class jhplot.HMLabel
Returns the X position of the text.
getX() - Method in class jhplot.jadraw.JaObject
Returns the x coordinate of this object.
getX(int) - Method in class jhplot.P1D
Return a specific X-value.
getX(int) - Method in class jhplot.P2D
Return a specific X-value.
getX(int) - Method in class jhplot.P3D
Return a specific X-value.
getX() - Method in class jhplot.v3d.Vector3d
 
getX() - Method in class org.apache.commons.math.geometry.Vector3D
Get the abscissa of the vector.
getX() - Method in class org.apache.commons.math.optimization.fitting.WeightedObservedPoint
Get the abscissa of the point.
getX(int, int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the X value for a bin.
getX(int, int) - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Returns the x-value at the specified index in the specified series.
getX() - Method in class umontreal.iro.lecuyer.functionfit.BSpline
Returns the Xi coordinates for this spline.
getX() - Method in class umontreal.iro.lecuyer.functionfit.LeastSquares
Returns the x coordinates of the fitted points.
getX() - Method in class umontreal.iro.lecuyer.functionfit.PolInterp
Returns the x coordinates of the interpolated points.
getX() - Method in class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Returns the xi coordinates for this spline.
getX() - Method in class umontreal.iro.lecuyer.functions.PiecewiseConstantFunction
Returns the X coordinates of the function.
getX0() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns the initial value X(t0) for this process.
getX1() - Method in class jhplot.jadraw.JaArcObject
Returns the x coordinate of the first click point of this arc.
getX1() - Method in class jhplot.jadraw.JaVertexT5
Returns the x coordinate of the first click point of this vertex.
getX2() - Method in class jhplot.jadraw.JaArcObject
Returns the x coordinate of the second click point of this arc.
getX2() - Method in class jhplot.jadraw.JaVertexT5
Returns the x coordinate of the second click point of this vertex.
getX3() - Method in class jhplot.jadraw.JaVertexT5
Returns the x coordinate of the third click point of this vertex.
getXAutoRange() - Method in class jhplot.SPlot
Get the range for X values of the data points registered so far.
getXAxis() - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Returns the chart's domain axis (x-axis) object.
getXAxis() - Method in class umontreal.iro.lecuyer.charts.XYChart
Returns the chart's domain axis (x-axis) object.
getXBar() - Method in class jhplot.stat.LinReg
Get average x
getXBar() - Method in class jhplot.stat.LinRegWeighted
Get average x
getXc() - Method in class umontreal.iro.lecuyer.probdist.InverseDistFromDensity
Returns the xc given in the constructor.
getXc() - Method in class umontreal.iro.lecuyer.randvar.InverseFromDensityGen
Returns the xc given in the constructor.
getXdata() - Method in class flanagan.analysis.Regression
 
getXi() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Returns the value of ξ for this object.
getXi() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Returns the value of ξ for this object.
getXi() - Method in class umontreal.iro.lecuyer.randvar.JohnsonSBGen
Returns the ξ associated with this object.
getXi() - Method in class umontreal.iro.lecuyer.randvar.JohnsonSUGen
Returns the ξ associated with this object.
getXinf() - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Returns xa such that the probability density is 0 everywhere outside the interval [xa, xb].
getXinf() - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
Returns the lower limit xa of the support of the distribution.
getXinf() - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
Returns the lower limit xa of the support of the probability mass function.
getXLabel() - Method in class jhplot.SPlot
Get the label for the X (horizontal) axis, or null if none has been set.
getXleft(int) - Method in class jhplot.P1D
Return a specific left error on X-value.
getXleftSys(int) - Method in class jhplot.P1D
Return a specific left error on X-value (systematic error).
getXLog() - Method in class jhplot.SPlot
Return whether the X axis is drawn with a logarithmic scale.
getXmax() - Method in class flanagan.interpolation.BiCubicSpline
 
getXmax() - Method in class flanagan.interpolation.BiCubicSplineFirstDerivative
 
getXmax() - Method in class flanagan.interpolation.BiCubicSplinePartialDerivative
 
getXmax() - Method in class flanagan.interpolation.CubicSpline
 
getXmax() - Method in class flanagan.interpolation.PolyCubicSpline
 
getXmax() - Method in class flanagan.interpolation.QuadriCubicSpline
 
getXmax() - Method in class flanagan.interpolation.TriCubicSpline
 
getXmin() - Method in class flanagan.interpolation.BiCubicSpline
 
getXmin() - Method in class flanagan.interpolation.BiCubicSplineFirstDerivative
 
getXmin() - Method in class flanagan.interpolation.BiCubicSplinePartialDerivative
 
getXmin() - Method in class flanagan.interpolation.CubicSpline
 
getXmin() - Method in class flanagan.interpolation.PolyCubicSpline
 
getXmin() - Method in class flanagan.interpolation.QuadriCubicSpline
 
getXmin() - Method in class flanagan.interpolation.TriCubicSpline
 
getXndc() - Method in class jhplot.jadraw.JaObject
Returns the NDC x coordinate of this object.
getXRange() - Method in class jhplot.SPlot
Get the X range.
getXright(int) - Method in class jhplot.P1D
Return a specific right error on X-value.
getXrightSys(int) - Method in class jhplot.P1D
Return a specific right error on X-value (systematic error).
getXSumSquares() - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the sum of squared deviations of the x values about their mean.
getXsup() - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Returns xb such that the probability density is 0 everywhere outside the interval [xa, xb].
getXsup() - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
Returns the upper limit xb of the support of the distribution.
getXsup() - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
Returns the upper limit xb of the support of the probability mass function.
getXTicks() - Method in class jhplot.SPlot
Get the X ticks that have been specified, or null if none.
getXuser() - Method in class jhplot.jadraw.JaObject
Returns the USER x coordinate of this object.
getXYCoord(int, int, int, int) - Method in class jhplot.jadraw.JaBox
Get coordinates of the box
getY(int) - Method in class jhplot.F1D
Get value in Y-axis
getY(int) - Method in class jhplot.FND
Get value in Y-axis
getY() - Method in class jhplot.HKey
Returns the Y position of the text.
getY() - Method in class jhplot.HLabel
Returns the Y position of the text.
getY() - Method in class jhplot.HLabelEq
Returns the Y position of the text.
getY() - Method in class jhplot.HMLabel
Returns the Y position of the text.
getY() - Method in class jhplot.jadraw.JaObject
Returns the y coordinate of this object.
getY(int) - Method in class jhplot.P1D
Return a specific Y-value.
getY(int) - Method in class jhplot.P2D
Return a specific Y-value.
getY(int) - Method in class jhplot.P3D
Return a specific Y-value.
getY() - Method in class jhplot.v3d.Vector3d
 
getY() - Method in class org.apache.commons.math.geometry.Vector3D
Get the ordinate of the vector.
getY() - Method in class org.apache.commons.math.optimization.fitting.WeightedObservedPoint
Get the observed value of the function at x.
getY(int, int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Returns the y-value for a bin (calculated to take into account the histogram type).
getY(int, int) - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Returns the y-value at the specified index in the specified series.
getY() - Method in class umontreal.iro.lecuyer.functionfit.BSpline
Returns the Yi coordinates for this spline.
getY() - Method in class umontreal.iro.lecuyer.functionfit.LeastSquares
Returns the y coordinates of the fitted points.
getY() - Method in class umontreal.iro.lecuyer.functionfit.PolInterp
Returns the y coordinates of the interpolated points.
getY() - Method in class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Returns the yi coordinates for this spline.
getY() - Method in class umontreal.iro.lecuyer.functions.PiecewiseConstantFunction
Returns the Y coordinates of the function.
getY1() - Method in class jhplot.jadraw.JaArcObject
Returns the y coordinate of the first click point of this arc.
getY1() - Method in class jhplot.jadraw.JaVertexT5
Returns the y coordinate of the first click point of this vertex.
getY2() - Method in class jhplot.jadraw.JaArcObject
Returns the y coordinate of the second click point of this arc.
getY2() - Method in class jhplot.jadraw.JaVertexT5
Returns the y coordinate of the second click point of this vertex.
getY3() - Method in class jhplot.jadraw.JaVertexT5
Returns the y coordinate of the third click point of this vertex.
getYAutoRange() - Method in class jhplot.SPlot
Get the range for Y values of the data points registered so far.
getYAxis() - Method in class umontreal.iro.lecuyer.charts.CategoryChart
Returns the chart's range axis (y-axis) object.
getYAxis() - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Returns the chart's range axis (y-axis) object.
getYAxis() - Method in class umontreal.iro.lecuyer.charts.XYChart
Returns the chart's range axis (y-axis) object.
getYBar() - Method in class jhplot.stat.LinReg
Get average Y
getYBar() - Method in class jhplot.stat.LinRegWeighted
Get average Y
getYcalc() - Method in class flanagan.analysis.Regression
 
getYdata() - Method in class flanagan.analysis.Regression
 
getYear() - Method in class flanagan.math.TimeAndDate
 
getYLabel() - Method in class jhplot.SPlot
Get the label for the Y (vertical) axis, or null if none has been set.
getYLog() - Method in class jhplot.SPlot
Return whether the Y axis is drawn with a logarithmic scale.
getYlower(int) - Method in class jhplot.P1D
Return a specific lower error on Y-value.
getYlowerSys(int) - Method in class jhplot.P1D
Return a specific total lower error on Y-value.
getYndc() - Method in class jhplot.jadraw.JaObject
Returns the NDC y coordinate of this object.
getYRange() - Method in class jhplot.SPlot
Get the Y range.
getYscale() - Method in class flanagan.analysis.Regression
 
getYscaleOption() - Method in class flanagan.analysis.Regression
 
getYTicks() - Method in class jhplot.SPlot
Get the Y ticks that have been specified, or null if none.
getYupper(int) - Method in class jhplot.P1D
Return a specific upper error on Y-value.
getYupperSys(int) - Method in class jhplot.P1D
Return a specific systematical upper error on Y-value.
getYuser() - Method in class jhplot.jadraw.JaObject
Returns the USER y coordinate of this object.
getZ(int) - Method in class jhplot.P2D
Return a specific Z-value.
getZ(int) - Method in class jhplot.P3D
Return a specific Z-value.
getZ() - Method in class jhplot.v3d.Vector3d
 
getZ() - Method in class org.apache.commons.math.geometry.Vector3D
Get the height of the vector.
getZero() - Method in class org.apache.commons.math.complex.ComplexField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math.dfp.Dfp
Get the constant 0.
getZero() - Method in class org.apache.commons.math.dfp.DfpField
Get the constant 0.
getZero() - Method in interface org.apache.commons.math.Field
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math.fraction.BigFractionField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math.fraction.FractionField
Get the additive identity of the field.
getZero() - Method in class org.apache.commons.math.util.BigRealField
Get the additive identity of the field.
getZeroOverZeroValue() - Method in class umontreal.iro.lecuyer.util.RatioFunction
Returns the value returned by evaluate in the case where the 0/0 function is calculated.
GeV - Static variable in class cern.clhep.Units
 
GHFrame - Class in jhplot
Create main Frame with several plots.
GHFrame(String, int, int, int, int, boolean) - Constructor for class jhplot.GHFrame
Create main frame window
GHFrame(String, int, int) - Constructor for class jhplot.GHFrame
Construct a GHFrame with a single plot/graph.
GHFrame(String, int, int, boolean) - Constructor for class jhplot.GHFrame
Construct a GHFrame canvas with a single plot/graph.
GHFrame(String, int, int, int, int) - Constructor for class jhplot.GHFrame
Construct a GHFrame canvas with plots/graphs.
GHFrame(String) - Constructor for class jhplot.GHFrame
Construct a GHFrame canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
GHFrame() - Constructor for class jhplot.GHFrame
Construct a GHFrame canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default".
GHMargin - Class in jhplot
Panels with global margin.
GHMargin(GHPanel, String) - Constructor for class jhplot.GHMargin
Main class to create global margin
GHPanel - Class in jhplot
Class to build the global panel with graphics.
GHPanel(int, int) - Constructor for class jhplot.GHPanel
Create a panel with graphics.
gigaelectronvolt - Static variable in class cern.clhep.Units
 
GillIntegrator - Class in org.apache.commons.math.ode.nonstiff
This class implements the Gill fourth order Runge-Kutta integrator for Ordinary Differential Equations .
GillIntegrator(double) - Constructor for class org.apache.commons.math.ode.nonstiff.GillIntegrator
Simple constructor.
GlArc(float, float, float, float, float, float) - Static method in class jhplot.jadraw.Diagram
 
GLine(float, float) - Static method in class jhplot.jadraw.Diagram
A g-line for ghost particles.
GlLine(float, float) - Static method in class jhplot.jadraw.Diagram
Get a gluon line object
GlLoop(float, float) - Static method in class jhplot.jadraw.Diagram
Get a gluon loop object
GlobalCPUTimeChrono - Class in umontreal.iro.lecuyer.util
Extends the AbstractChrono class to compute the global CPU time used by the Java Virtual Machine.
GlobalCPUTimeChrono() - Constructor for class umontreal.iro.lecuyer.util.GlobalCPUTimeChrono
Constructs a Chrono object and initializes it to zero.
GLoop(float, float) - Static method in class jhplot.jadraw.Diagram
Get a g-loop object
GLSMultipleLinearRegression - Class in org.apache.commons.math.stat.regression
The GLS implementation of the multiple linear regression.
GLSMultipleLinearRegression() - Constructor for class org.apache.commons.math.stat.regression.GLSMultipleLinearRegression
 
GNUPLOT - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Data file format used for plotting functions with Gnuplot.
GoalType - Enum in org.apache.commons.math.optimization
Goal type for an optimization problem.
GofFormat - Class in umontreal.iro.lecuyer.gof
This class contains methods used to format results of GOF test statistics, or to apply a series of tests simultaneously and format the results.
GofStat - Class in umontreal.iro.lecuyer.gof
This class provides methods to compute several types of EDF goodness-of-fit test statistics and to apply certain transformations to a set of observations.
GofStat.OutcomeCategoriesChi2 - Class in umontreal.iro.lecuyer.gof
This class helps managing the partitions of possible outcomes into categories for applying chi-square tests.
GofStat.OutcomeCategoriesChi2(double[]) - Constructor for class umontreal.iro.lecuyer.gof.GofStat.OutcomeCategoriesChi2
Constructs an OutcomeCategoriesChi2 object using the array nbExp for the number of expected observations in each category.
GofStat.OutcomeCategoriesChi2(double[], int, int) - Constructor for class umontreal.iro.lecuyer.gof.GofStat.OutcomeCategoriesChi2
Constructs an OutcomeCategoriesChi2 object using the given nbExp expected observations array.
GofStat.OutcomeCategoriesChi2(double[], int[], int, int, int) - Constructor for class umontreal.iro.lecuyer.gof.GofStat.OutcomeCategoriesChi2
Constructs an OutcomeCategoriesChi2 object.
goodFriday() - Method in class flanagan.math.TimeAndDate
 
goodFriday(int) - Method in class flanagan.math.TimeAndDate
 
gradient(double[]) - Method in class hep.aida.ref.fitter.InternalFitFunction
 
gradient(double[]) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
gradient(double[]) - Method in class hep.aida.ref.function.AbstractIFunction
 
gradient(double[]) - Method in class hep.aida.ref.function.BaseModelFunction
 
gradient(double[]) - Method in class hep.aida.ref.function.ExponentialCoreNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.ExponentialCoreNotNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.FunctionCore
 
gradient(double[]) - Method in class hep.aida.ref.function.GaussianCore2DNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.GaussianCore2DNotNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.GaussianCoreNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.GaussianCoreNotNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.JELFunctionCore
 
gradient(double[]) - Method in class hep.aida.ref.function.LorentzianCoreNotNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.MoyalCoreNotNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.PolynomialCoreNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.PolynomialCoreNotNorm
 
gradient(double[]) - Method in class hep.aida.ref.function.SumOfFunctions
 
gradient() - Method in interface org.apache.commons.math.analysis.DifferentiableMultivariateRealFunction
Returns the gradient function.
gradient(double, double[]) - Method in class org.apache.commons.math.optimization.fitting.ParametricGaussianFunction
Computes the gradient vector for a four variable version of the function where the parameters, a, b, c, and d, are considered the variables, not x.
gradient(double, double[]) - Method in interface org.apache.commons.math.optimization.fitting.ParametricRealFunction
Compute the gradient of the function with respect to its parameters.
GraggBulirschStoerIntegrator - Class in org.apache.commons.math.ode.nonstiff
This class implements a Gragg-Bulirsch-Stoer integrator for Ordinary Differential Equations.
GraggBulirschStoerIntegrator(double, double, double, double) - Constructor for class org.apache.commons.math.ode.nonstiff.GraggBulirschStoerIntegrator
Simple constructor.
GraggBulirschStoerIntegrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.nonstiff.GraggBulirschStoerIntegrator
Simple constructor.
gram - Static variable in class cern.clhep.Units
 
gramToOunce(double) - Static method in class flanagan.math.Conv
 
gramToOunce(double) - Static method in class flanagan.math.Fmath
 
graph(Graphics) - Method in class flanagan.math.FourierTransform
 
graphDistUnif(DoubleArrayList, String) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Formats data to plot the empirical distribution of U(1),..., U(N), which are assumed to be in data[0...N-1], and to compare it with the uniform distribution.
graphSoft - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Environment variable that selects the type of software to be used for plotting the graphs of functions.
gray - Static variable in class cern.clhep.Units
 
greater(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A[row,col] = A[row,col] > s ? 1 : 0.
greater(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A[row,col] = A[row,col] > B[row,col] ? 1 : 0.
greater - Static variable in class cern.jet.math.Functions
Function that returns a > b ? 1 : 0.
greater(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a > b ? 1 : 0.
greater - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a > b ? 1 : 0.
greater(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a > b ? 1 : 0.
greater - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a > b ? 1 : 0.
greater(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a > b ? 1 : 0.
greaterThan(Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Check if instance is greater than x.
Grid - Class in hep.aida.ref.function
 
Grid(IModelFunction) - Constructor for class hep.aida.ref.function.Grid
 
guess() - Method in class org.apache.commons.math.optimization.fitting.GaussianParametersGuesser
Guesses the parameters based on the observed points.
guess() - Method in class org.apache.commons.math.optimization.fitting.HarmonicCoefficientsGuesser
Estimate a first guess of the coefficients.
guessParametersErrors(EstimationProblem) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Deprecated. Guess the errors in unbound estimated parameters.
guessParametersErrors(EstimationProblem) - Method in interface org.apache.commons.math.estimation.Estimator
Deprecated. Guess the errors in estimated parameters.
guessParametersErrors() - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Guess the errors in optimized parameters.
GumbelDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Gumbel distribution, with location parameter δ and scale parameter β≠ 0.
GumbelDist() - Constructor for class umontreal.iro.lecuyer.probdist.GumbelDist
Constructor for the standard Gumbel distribution with parameters β = 1 and δ = 0.
GumbelDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.GumbelDist
Constructs a GumbelDist object with parameters β = beta and δ = delta.
GumbelGen - Class in umontreal.iro.lecuyer.randvar
This class implements methods for generating random variates from the Gumbel distribution.
GumbelGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.GumbelGen
Creates a Gumbel random number generator with β = 1 and δ = 0 using stream s.
GumbelGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.GumbelGen
Creates a Gumbel random number generator with parameters β = beta and δ = delta using stream s.
GumbelGen(RandomStream, GumbelDist) - Constructor for class umontreal.iro.lecuyer.randvar.GumbelGen
Creates a new generator for the Gumbel distribution dist and stream s.
gumbelMax() - Method in class flanagan.analysis.Regression
 
gumbelMax(double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxMean(double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxMedian(double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxMode(double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxMu() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxMuError() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxOnePar() - Method in class flanagan.analysis.Regression
 
gumbelMaxOneParPlot() - Method in class flanagan.analysis.Regression
 
gumbelMaxOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
gumbelMaxPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxPlot() - Method in class flanagan.analysis.Regression
 
gumbelMaxProb(double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxProb(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
gumbelMaxRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
gumbelMaxSigma() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxSigmaError() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMaxStandard() - Method in class flanagan.analysis.Regression
 
gumbelMaxStandardDeviation(double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxStandardPlot() - Method in class flanagan.analysis.Regression
 
gumbelMaxStandDev(double) - Static method in class flanagan.analysis.Stat
 
gumbelMaxSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMin() - Method in class flanagan.analysis.Regression
 
gumbelMin(double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMinCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMinCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMinMean(double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMinMedian(double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMinMode(double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMinMu() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinMuError() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinOnePar() - Method in class flanagan.analysis.Regression
 
gumbelMinOneParPlot() - Method in class flanagan.analysis.Regression
 
gumbelMinOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
gumbelMinPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMinPlot() - Method in class flanagan.analysis.Regression
 
gumbelMinProb(double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMinProb(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMinProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinProbCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
gumbelMinRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
gumbelMinRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
gumbelMinSigma() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinSigmaError() - Method in class flanagan.analysis.ProbabilityPlot
 
gumbelMinStandard() - Method in class flanagan.analysis.Regression
 
gumbelMinStandardDeviation(double) - Static method in class flanagan.analysis.Stat
 
gumbelMinStandardPlot() - Method in class flanagan.analysis.Regression
 
gumbelMinStandDev(double) - Static method in class flanagan.analysis.Stat
 
gumbelMinSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 

H

H - Static variable in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Step length in x to compute derivatives.
H1D - Class in jhplot
Class to create a histogram in one dimension (1D).
H1D() - Constructor for class jhplot.H1D
Build 1D histogram.
H1D(String, int, double, double) - Constructor for class jhplot.H1D
Build 1D histogram
H1D(String, double[]) - Constructor for class jhplot.H1D
Create 1D histogram with variable bin size.
H1D(String, IAxis) - Constructor for class jhplot.H1D
Create 1D histogram with variable bin size.
H1D(Histogram1D) - Constructor for class jhplot.H1D
Create H1D histogram from JAIDA Histogram1D class.
H1D(Cloud1D, int) - Constructor for class jhplot.H1D
Create H1D histogram from JAIDA Cloud1D class.
H1D(IHistogram1D) - Constructor for class jhplot.H1D
Create H1D histogram from JAIDA IHistogram1D class
H1D(String, H1D) - Constructor for class jhplot.H1D
Create H1D from another instance.
H1D(TH1) - Constructor for class jhplot.H1D
Create H1D histogram from JAIDA TH1 histogram class
H2D - Class in jhplot
Main class to create a 2D histogram.
H2D(String, int, double, double, int, double, double) - Constructor for class jhplot.H2D
Create 2D histogram
H2D(IHistogram2D) - Constructor for class jhplot.H2D
Create H2D histogram from JAIDA IHistogram2D class
H2D(Cloud2D, int, int) - Constructor for class jhplot.H2D
Create H2D histogram from Cloud2D.
H2D(String, double[], double[]) - Constructor for class jhplot.H2D
Create a 2D histogram using variable size bins in X and Y
H2D(String, IAxis, IAxis) - Constructor for class jhplot.H2D
Define H2D in terms of axis
H2D(Histogram2D) - Constructor for class jhplot.H2D
Create a H2D histogram from JAIDA histogram
H2D(TH2) - Constructor for class jhplot.H2D
Create H2D histogram from JAIDA TH1 histogram class
H3D - Class in jhplot
Create histogram in 3D
H3D(String, IAxis, IAxis, IAxis) - Constructor for class jhplot.H3D
Create 3D histogram
h_Planck - Static variable in class cern.clhep.PhysicalConstants
 
H_PLANCK - Static variable in class flanagan.math.Fmath
 
H_PLANCK_RED - Static variable in class flanagan.math.Fmath
 
HALF_LOG_2_PI - Static variable in interface jhplot.math.num.Constants
1/2 * log(2 π).
HalfNormalDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the half-normal distribution with parameters μ and σ > 0.
HalfNormalDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.HalfNormalDist
Constructs a HalfNormalDist object with parameters μ = mu and σ = sigma.
HalfNormalGen - Class in umontreal.iro.lecuyer.randvar
This class implements methods for generating random variates from the half-normal distribution with parameters μ and σ > 0.
HalfNormalGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.HalfNormalGen
Creates a new half-normal generator with parameters μ = mu and σ = sigma, using stream s.
HalfNormalGen(RandomStream, HalfNormalDist) - Constructor for class umontreal.iro.lecuyer.randvar.HalfNormalGen
Creates a new generator for the distribution dist, using stream s.
halfpi - Static variable in class cern.clhep.PhysicalConstants
 
HaltonSequence - Class in umontreal.iro.lecuyer.hups
This class implements the sequence of Halton, which is essentially a modification of Hammersley nets for producing an infinite sequence of points having low discrepancy.
HaltonSequence(int) - Constructor for class umontreal.iro.lecuyer.hups.HaltonSequence
Constructs a new Halton sequence in dim dimensions.
HammersleyPointSet - Class in umontreal.iro.lecuyer.hups
This class implements Hammersley point sets, which are defined as follows.
HammersleyPointSet(int, int) - Constructor for class umontreal.iro.lecuyer.hups.HammersleyPointSet
Constructs a new Hammersley point set with n points in dim dimensions.
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Handle the last accepted step.
handleStep(StepInterpolatorWithJacobians, boolean) - Method in interface org.apache.commons.math.ode.jacobians.StepHandlerWithJacobians
Deprecated. Handle the last accepted step
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math.ode.sampling.DummyStepHandler
Handle the last accepted step.
handleStep(double, double[], double[], boolean) - Method in interface org.apache.commons.math.ode.sampling.FixedStepHandler
Handle the last accepted step
handleStep(StepInterpolator, boolean) - Method in interface org.apache.commons.math.ode.sampling.StepHandler
Handle the last accepted step
handleStep(StepInterpolator, boolean) - Method in class org.apache.commons.math.ode.sampling.StepNormalizer
Handle the last accepted step
harmonic(long) - Static method in class umontreal.iro.lecuyer.util.Num
Computes the n-th harmonic number Hn = ∑j=1n1/j.
harmonic2(long) - Static method in class umontreal.iro.lecuyer.util.Num
.
HarmonicCoefficientsGuesser - Class in org.apache.commons.math.optimization.fitting
This class guesses harmonic coefficients from a sample.
HarmonicCoefficientsGuesser(WeightedObservedPoint[]) - Constructor for class org.apache.commons.math.optimization.fitting.HarmonicCoefficientsGuesser
Simple constructor.
HarmonicFitter - Class in org.apache.commons.math.optimization.fitting
This class implements a curve fitting specialized for sinusoids.
HarmonicFitter(DifferentiableMultivariateVectorialOptimizer) - Constructor for class org.apache.commons.math.optimization.fitting.HarmonicFitter
Simple constructor.
HarmonicFitter(DifferentiableMultivariateVectorialOptimizer, double[]) - Constructor for class org.apache.commons.math.optimization.fitting.HarmonicFitter
Simple constructor.
HarmonicFunction - Class in org.apache.commons.math.optimization.fitting
Harmonic function of the form f (t) = a cos (ω t + φ).
HarmonicFunction(double, double, double) - Constructor for class org.apache.commons.math.optimization.fitting.HarmonicFunction
Simple constructor.
harmonicMean() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the harmonic mean, which is size() / Sum( 1/x[i] ).
harmonicMean(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the harmonic mean of a data sequence.
harmonicMean(int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the harmonic mean of a data sequence.
harmonicMean(int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the harmonic mean of a data sequence.
harmonicMean() - Method in class flanagan.analysis.Stat
 
harmonicMean(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
harmonicMean(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
harmonicMean(Complex[]) - Static method in class flanagan.analysis.Stat
 
harmonicMean(double[]) - Static method in class flanagan.analysis.Stat
 
harmonicMean(float[]) - Static method in class flanagan.analysis.Stat
 
harmonicMean(BigDecimal[], BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
harmonicMean(BigInteger[], BigInteger[]) - Static method in class flanagan.analysis.Stat
 
harmonicMean(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
harmonicMean(double[], double[]) - Static method in class flanagan.analysis.Stat
 
harmonicMean(float[], float[]) - Static method in class flanagan.analysis.Stat
 
harmonicMean() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the harmonic mean, which is size() / Sum( 1/x[i] ).
harmonicMean() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the harmonic mean, which is size() / Sum( 1/x[i] ).
harmonicMean_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
harmonicMean_as_Complex() - Method in class flanagan.analysis.Stat
 
harmonicMean_as_double() - Method in class flanagan.analysis.Stat
 
hasBeenFilled(String) - Method in class hep.aida.ref.tree.Tree
Is called by the Store to let Tree know that a particular folder has been filled already.
hasColumnIndexesSorted() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Returns true if column indexes are sorted, false otherwise
hasColumnIndexesSorted() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Returns true if column indexes are sorted, false otherwise
hasColumnIndexesSorted() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Returns true if column indexes are sorted, false otherwise
hasColumnIndexesSorted() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Returns true if column indexes are sorted, false otherwise
hasColumnIndexesSorted() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Returns true if column indexes are sorted, false otherwise
hasDefaultValue() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
hasDefaultValue() - Method in interface hep.aida.ref.tuple.FTupleColumn
 
hasDefaultValue() - Method in class hep.aida.ref.tuple.TupleColumn
 
HasDensity<P> - Interface in org.apache.commons.math.distribution
Deprecated. to be removed in math 3.0
HasFTuple - Interface in hep.aida.ref.tuple
 
hasFullRank() - Method in class cern.colt.matrix.linalg.QRDecomposition
Returns whether the matrix A has full rank.
hasFullRank() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleQRDecomposition
Returns whether the matrix A has full rank.
hasFullRank() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleQRDecomposition
Returns whether the matrix A has full rank.
hasFullRank() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatQRDecomposition
Returns whether the matrix A has full rank.
hasFullRank() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatQRDecomposition
Returns whether the matrix A has full rank.
hash(char) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(double) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(float) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(int) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(long) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(Object) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified object.
hash(short) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(boolean) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(byte) - Static method in class cern.colt.map.HashFunctions
Returns a hashcode for the specified value.
hash(double) - Static method in class org.apache.commons.math.util.MathUtils
Returns an integer hash code representing the given double value.
hash(double[]) - Static method in class org.apache.commons.math.util.MathUtils
Returns an integer hash code representing the given double array.
hashCode() - Method in class cern.colt.bitvector.BitMatrix
Returns a hash code value for the receiver.
hashCode() - Method in class cern.colt.bitvector.BitVector
Returns a hash code value for the receiver.
hashCode() - Method in class cern.colt.matrix.tbit.BitMatrix
Returns a hash code value for the receiver.
hashCode() - Method in class cern.colt.matrix.tbit.BitVector
Returns a hash code value for the receiver.
hashCode() - Method in class flanagan.analysis.ErrorProp
 
hashCode() - Method in class hephysics.particle.LParticle
Get a hash code
hashCode() - Method in class hephysics.vec.Hep3Vector
 
hashCode() - Method in class hephysics.vec.HepLorentzVector
Hash code
hashCode() - Method in class jhplot.math.ValueErr
 
hashCode() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
hashCode() - Method in class org.apache.commons.math.complex.Complex
Get a hashCode for the complex number.
hashCode() - Method in class org.apache.commons.math.dfp.Dfp
Gets a hashCode for the instance.
hashCode() - Method in class org.apache.commons.math.fraction.BigFraction
Gets a hashCode for the fraction.
hashCode() - Method in class org.apache.commons.math.fraction.Fraction
Gets a hashCode for the fraction.
hashCode() - Method in class org.apache.commons.math.geometry.Vector3D
Get a hashCode for the 3D vector.
hashCode() - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Computes a hashcode for the matrix.
hashCode() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Computes a hashcode for the matrix.
hashCode() - Method in class org.apache.commons.math.linear.ArrayFieldVector
Get a hashCode for the real vector.
hashCode() - Method in class org.apache.commons.math.linear.ArrayRealVector
Get a hashCode for the real vector.
hashCode() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Computes a hashcode for the matrix.
hashCode() - Method in class org.apache.commons.math.linear.OpenMapRealVector
hashCode() - Method in class org.apache.commons.math.linear.SparseFieldVector
hashCode() - Method in class org.apache.commons.math.optimization.linear.LinearConstraint
hashCode() - Method in class org.apache.commons.math.optimization.linear.LinearObjectiveFunction
hashCode() - Method in class org.apache.commons.math.stat.clustering.EuclideanIntegerPoint
hashCode() - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
Returns hash code based on getResult() and getN()
hashCode() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
hashCode() - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialMean
hashCode() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Returns hash code based on values of statistics
hashCode() - Method in class org.apache.commons.math.stat.Frequency
hashCode() - Method in class org.apache.commons.math.util.BigReal
hashCode() - Method in class org.apache.commons.math.util.DefaultTransformer
hashCode() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns a hash code consistent with equals.
hashCode() - Method in class org.apache.commons.math.util.TransformerMap
hashCode() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
HashFunctions - Class in cern.colt.map
Provides various hash functions.
hasInfo() - Method in class cern.colt.matrix.io.MatrixVectorReader
Checks if a Matrix Market header is present ("%%MatrixMarket")
hasKey(String) - Method in class hep.aida.ref.Annotation
 
hasNext() - Method in class org.apache.commons.math.util.MultidimensionalCounter.Iterator
hasNext() - Method in class org.apache.commons.math.util.OpenIntToDoubleHashMap.Iterator
Check if there is a next element in the map.
hasNext() - Method in class org.apache.commons.math.util.OpenIntToFieldHashMap.Iterator
Check if there is a next element in the map.
hasNextCoordinate() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
hasNextCoordinate() - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Returns true if the current point has another coordinate.
hasNextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Returns true if j < d, where j is the number of observations of the current sample path generated since the last call to resetStartProcess.
hasNextPoint() - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Returns true if there is a next point.
hasRowIndexesSorted() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Returns true if row indexes are sorted, false otherwise
hasRowIndexesSorted() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Returns true if row indexes are sorted, false otherwise
hasRowIndexesSorted() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Returns true if row indexes are sorted, false otherwise
hasRowIndexesSorted() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Returns true if row indexes are sorted, false otherwise
hasRowIndexesSorted() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Returns true if row indexes are sorted, false otherwise
hasStore() - Method in class hep.aida.ref.tree.Tree
 
hasSumOfInversions() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns whether sumOfInversions() can return meaningful results.
hasSumOfInversions() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns whether sumOfInversions() can return meaningful results.
hasSumOfInversions() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns whether sumOfInversions() can return meaningful results.
hasSumOfLogarithms() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Tells whether sumOfLogarithms() can return meaningful results.
hasSumOfLogarithms() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Tells whether sumOfLogarithms() can return meaningful results.
hasSumOfLogarithms() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Tells whether sumOfLogarithms() can return meaningful results.
hasSumOfPowers(int) - Method in class cern.hep.aida.bin.MightyStaticBin1D
Tells whether sumOfPowers(k) can return meaningful results.
hasSumOfPowers(int) - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Tells whether sumOfPowers(k) can return meaningful results.
hasSumOfPowers(int) - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Tells whether sumOfPowers(k) can return meaningful results.
hav(double) - Static method in class flanagan.math.Fmath
 
hbar_Planck - Static variable in class cern.clhep.PhysicalConstants
 
hbarc - Static variable in class cern.clhep.PhysicalConstants
 
hbarc_squared - Static variable in class cern.clhep.PhysicalConstants
 
HBayes - Class in jhplot
HBayes is a set of tools for the creation and manipulation of Bayesian networks.
HBayes() - Constructor for class jhplot.HBayes
Initialize .
HBook - Class in jhplot
This class is used to book histograms for writing and reading.
HBook(String) - Constructor for class jhplot.HBook
Initialize HBook.
HBook() - Constructor for class jhplot.HBook
Initialize HBook class.
HBsom - Class in jhplot
The Bayesian self-organizing map (BSOM).
HBsom() - Constructor for class jhplot.HBsom
Initialize BSOM.
HCellular - Class in jhplot
A two-dimensional cellular automata toolkit.
HCellular() - Constructor for class jhplot.HCellular
Build a Cellular automata.
HChart - Class in jhplot
Create various charts, such as pie, histograms, bar charts including 3D emulation, lines.
HChart(String, int, int, int, int, boolean) - Constructor for class jhplot.HChart
Create HChart canvas with a several chart plots
HChart(String, int, int) - Constructor for class jhplot.HChart
Construct a HChart canvas with a single plot/graph
HChart(String, int, int, boolean) - Constructor for class jhplot.HChart
Construct a HChart canvas with a single plot/graph
HChart(String, int, int, int, int) - Constructor for class jhplot.HChart
Construct a HChart canvas with plots/graphs
HChart(String) - Constructor for class jhplot.HChart
Construct a HChart canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
HChart() - Constructor for class jhplot.HChart
Construct a HChart canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default"
HCluster - Class in jhplot
A Canvas to build a canvas for interactive data clustering.
HCluster() - Constructor for class jhplot.HCluster
Show a frame for clustering.
HCluster(DataHolder) - Constructor for class jhplot.HCluster
Show jMinHEP frame for clustering analysis.
HDataBase - Class in jhplot.io
This raw-level database allows to store and retrieve objects.
HDataBase(String, String) - Constructor for class jhplot.io.HDataBase
Create a new persistent database.
HDataBase(String) - Constructor for class jhplot.io.HDataBase
Open the database file for reading.
HeaderColumnNameMappingStrategy - Class in jhplot.io.csv.bean
Copyright 2007 Kyle Miller.
HeaderColumnNameMappingStrategy() - Constructor for class jhplot.io.csv.bean.HeaderColumnNameMappingStrategy
 
HeaderColumnNameTranslateMappingStrategy - Class in jhplot.io.csv.bean
Copyright 2007 Kyle Miller.
HeaderColumnNameTranslateMappingStrategy() - Constructor for class jhplot.io.csv.bean.HeaderColumnNameTranslateMappingStrategy
 
height(int[]) - Method in interface hep.aida.ref.dataset.binner.Binner
Get the height of a bin.
height(int[]) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Get the height of a bin.
height(int[]) - Method in class hep.aida.ref.dataset.binner.EfficiencyBinner
Get the height of a bin.
height(int) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
height(int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
height(int, int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
height(int) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
height(int, int) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
height(int, int, int) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
height(int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
height(int, int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
HelpBrowser - Class in jhplot
Used to display on-line help for jHplot package
HelpBrowser(String) - Constructor for class jhplot.HelpBrowser
Show online browser
HelpBrowser(URL) - Constructor for class jhplot.HelpBrowser
Show online browser
Henriksen - Class in umontreal.iro.lecuyer.simevents.eventlist
An implementation of EventList using the doubly-linked indexed list of Henriksen (see also).
Henriksen() - Constructor for class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
henry - Static variable in class cern.clhep.Units
 
hep.aida.ref - package hep.aida.ref
Reference implementation of AIDA (see documentation).
hep.aida.ref.dataset - package hep.aida.ref.dataset
 
hep.aida.ref.dataset.binner - package hep.aida.ref.dataset.binner
 
hep.aida.ref.event - package hep.aida.ref.event
 
hep.aida.ref.fitter - package hep.aida.ref.fitter
 
hep.aida.ref.fitter.fitdata - package hep.aida.ref.fitter.fitdata
 
hep.aida.ref.fitter.fitmethod - package hep.aida.ref.fitter.fitmethod
 
hep.aida.ref.function - package hep.aida.ref.function
 
hep.aida.ref.function.examples - package hep.aida.ref.function.examples
 
hep.aida.ref.histogram - package hep.aida.ref.histogram
 
hep.aida.ref.histogram.binner - package hep.aida.ref.histogram.binner
 
hep.aida.ref.tree - package hep.aida.ref.tree
 
hep.aida.ref.tuple - package hep.aida.ref.tuple
 
hep.aida.tdouble - package hep.aida.tdouble
Interfaces for compact, extensible, modular and performant histogramming functionality.
hep.aida.tdouble.bin - package hep.aida.tdouble.bin
Multisets (bags) with efficient statistics operations defined upon; This package requires the Colt distribution.
hep.aida.tdouble.ref - package hep.aida.tdouble.ref
Reference implementation of the AIDA histogram interfaces.
hep.aida.tfloat - package hep.aida.tfloat
Interfaces for compact, extensible, modular and performant histogramming functionality.
hep.aida.tfloat.bin - package hep.aida.tfloat.bin
Multisets (bags) with efficient statistics operations defined upon; This package requires the Colt distribution.
hep.aida.tfloat.ref - package hep.aida.tfloat.ref
Reference implementation of the AIDA histogram interfaces.
Hep3Matrix - Class in hephysics.vec
Hep 3x3 matrices
Hep3Matrix(int, int) - Constructor for class hephysics.vec.Hep3Matrix
 
Hep3Matrix(double[][]) - Constructor for class hephysics.vec.Hep3Matrix
Creates a new instance of BasicMatrix
Hep3Matrix() - Constructor for class hephysics.vec.Hep3Matrix
 
Hep3Matrix(double, double, double, double, double, double, double, double, double) - Constructor for class hephysics.vec.Hep3Matrix
 
Hep3Matrix(Matrix) - Constructor for class hephysics.vec.Hep3Matrix
 
Hep3Vector - Class in hephysics.vec
Basic implementation of a Hep3Vector
Hep3Vector() - Constructor for class hephysics.vec.Hep3Vector
New 3-vector
Hep3Vector(double, double, double) - Constructor for class hephysics.vec.Hep3Vector
Define a 3-vector
Hep3Vector(double[]) - Constructor for class hephysics.vec.Hep3Vector
Create a BasicHep3Vector from a double array
Hep3Vector(float[]) - Constructor for class hephysics.vec.Hep3Vector
Define a new vector
hep_pascal - Static variable in class cern.clhep.Units
 
HEParticle - Class in hephysics.particle
a HEP-type basic particle based on 4-Lorentz vector.
HEParticle(String, double) - Constructor for class hephysics.particle.HEParticle
Define a particle with a name and mass
HEParticle(double, double, double) - Constructor for class hephysics.particle.HEParticle
Define a 3-momentum for a given particle.
HEParticle(double, double, double, double, double) - Constructor for class hephysics.particle.HEParticle
Define a 4-momentum and energy particle
HEParticle(HepLorentzVector, HepLorentzVector, double) - Constructor for class hephysics.particle.HEParticle
Define a particle in momentum and position
HEParticle(double, double, double, double) - Constructor for class hephysics.particle.HEParticle
Define a particle in momentum space.
HEParticle(String, double, double, double, double, double) - Constructor for class hephysics.particle.HEParticle
Define a Lorentz particle in momentum space.
hephysics.matrix - package hephysics.matrix
Simple matrix package.
hephysics.particle - package hephysics.particle
Define various Lorentz-type particles.
hephysics.vec - package hephysics.vec
Lorentz-type vectors and transformations.
HepLorentzVector - Class in hephysics.vec
a HepLorentzVector (4-vector) It can hold either space-coordinate and time (x,y,z,t) or 4-momentum (px,py,pz,energy).
HepLorentzVector() - Constructor for class hephysics.vec.HepLorentzVector
Default Lorentz vector constructor
HepLorentzVector(double, double, double, double) - Constructor for class hephysics.vec.HepLorentzVector
Define a Lorentz vector This can either be (x,y,z,time) or (px,py,pz,energy)
HepLorentzVector(double[], double) - Constructor for class hephysics.vec.HepLorentzVector
Define a Lorentz vector
HepLorentzVector(float[], double) - Constructor for class hephysics.vec.HepLorentzVector
Define a Lorentz vector
HepLorentzVector(Hep3Vector, double) - Constructor for class hephysics.vec.HepLorentzVector
Define Lorentz vector
hertz - Static variable in class cern.clhep.Units
 
hessenbergMatrix() - Method in class flanagan.math.Matrix
 
HFile - Class in jhplot.io
Write or read objects in sequential order using the Java serialization.
HFile(String, String, boolean, int) - Constructor for class jhplot.io.HFile
Open a file to write/read objects to/from a serialized file in sequential order.
HFile(String, String, boolean) - Constructor for class jhplot.io.HFile
Open a file to write/read objects to/from a serialized file in sequential order.
HFile(String) - Constructor for class jhplot.io.HFile
Open file for reading objects from a serialized file in sequential order.
HFile(String, String) - Constructor for class jhplot.io.HFile
Open file for reading objects from a serialized file in sequential order.
HFileBrowser - Class in jhplot.io
A GUI to browser data stored in a HFile format (gzipped by default)
HFileBrowser(HPlot, HFile, boolean) - Constructor for class jhplot.io.HFileBrowser
Open HFile file in a pop-up window to browser it and check all objects
HFileXML - Class in jhplot.io
Open a XML file to write/read objects in sequential order using java serialization in XML.
HFileXML(String, String, int) - Constructor for class jhplot.io.HFileXML
Open a XML file to write or read objects to/from a serialized file in sequential order.
HFileXML(String, String) - Constructor for class jhplot.io.HFileXML
Open a XML file to write or read objects to/from a serialized file in sequential order.
HFileXML(String) - Constructor for class jhplot.io.HFileXML
Open a XML file to write or read objects to/from a serialized file in sequential order.
HFit - Class in jhplot
Main class for fit data or histograms.
HFit() - Constructor for class jhplot.HFit
Show an empty fit frame.
HFit(HPlot, String) - Constructor for class jhplot.HFit
Show an empty fit frame and pass HPlot object.
HFit(HPlot, H1D) - Constructor for class jhplot.HFit
Show a fit frame for a selected histogram.
HFit(HPlot, P1D) - Constructor for class jhplot.HFit
Show a fit frame for a selected histogram.
HFit(HPlot, String, Object, String) - Constructor for class jhplot.HFit
Show a fit frame for a selected histogram.
HFitter - Class in jhplot
Fit data (H1D or P1D).
HFitter(String) - Constructor for class jhplot.HFitter
Create a fitter using some method.
HFitter() - Constructor for class jhplot.HFitter
Create a fitter with Chi2 method by default
HGraph - Class in jhplot
Create a frame with interactive graphs.
HGraph(String, int, int, int, int, boolean) - Constructor for class jhplot.HGraph
Create HGraph canvas with several graphs.
HGraph(String, int, int) - Constructor for class jhplot.HGraph
Construct a HPlot canvas with a single plot/graph
HGraph(String, int, int, boolean) - Constructor for class jhplot.HGraph
Construct a HGraph canvas with a single plot/graph
HGraph(String, int, int, int, int) - Constructor for class jhplot.HGraph
Construct a HGraph canvas with plots/graphs
HGraph(String) - Constructor for class jhplot.HGraph
Construct a HGraph canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
HGraph() - Constructor for class jhplot.HGraph
Construct a HGraph canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default"
HighamHall54Integrator - Class in org.apache.commons.math.ode.nonstiff
This class implements the 5(4) Higham and Hall integrator for Ordinary Differential Equations.
HighamHall54Integrator(double, double, double, double) - Constructor for class org.apache.commons.math.ode.nonstiff.HighamHall54Integrator
Simple constructor.
HighamHall54Integrator(double, double, double[], double[]) - Constructor for class org.apache.commons.math.ode.nonstiff.HighamHall54Integrator
Simple constructor.
histF() - Method in class jhplot.HPlot
Return IHistogramFactory associated with the plot
histF() - Method in class jhplot.HPlotJa
Return IHistogramFactory associated with the plot
histogram(IHistogram1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Fills all cells of the given vector into the given histogram.
histogram(IHistogram2D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Fills all cells of the given vectors into the given histogram.
histogram(IHistogram2D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Fills all cells of the given vectors into the given histogram.
histogram(IHistogram3D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Statistic
Fills all cells of the given vectors into the given histogram.
histogram(DoubleIHistogram1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Fills all cells of the given vector into the given histogram.
histogram(DoubleIHistogram1D, DoubleMatrix2D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Fills all cells of the given matrix into the given histogram.
histogram(DoubleIHistogram1D[][], DoubleMatrix2D, int, int) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Splits the given matrix into m x n pieces and computes 1D histogram of each piece.
histogram(DoubleIHistogram2D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Fills all cells of the given vectors into the given histogram.
histogram(DoubleIHistogram2D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Fills all cells of the given vectors into the given histogram.
histogram(DoubleIHistogram3D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Fills all cells of the given vectors into the given histogram.
histogram(FloatIHistogram1D, FloatMatrix1D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Fills all cells of the given vector into the given histogram.
histogram(FloatIHistogram1D, FloatMatrix2D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Fills all cells of the given matrix into the given histogram.
histogram(FloatIHistogram1D[][], FloatMatrix2D, int, int) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Splits the given matrix into m x n pieces and computes 1D histogram of each piece.
histogram(FloatIHistogram2D, FloatMatrix1D, FloatMatrix1D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Fills all cells of the given vectors into the given histogram.
histogram(FloatIHistogram2D, FloatMatrix1D, FloatMatrix1D, FloatMatrix1D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Fills all cells of the given vectors into the given histogram.
histogram(FloatIHistogram3D, FloatMatrix1D, FloatMatrix1D, FloatMatrix1D, FloatMatrix1D) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Fills all cells of the given vectors into the given histogram.
histogram() - Method in class hep.aida.ref.histogram.Cloud1D
Get the Histogram representing the Cloud
histogram() - Method in class hep.aida.ref.histogram.Cloud2D
Get the Histogram representing the Cloud
histogram() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Histogram representing the Cloud
Histogram - Class in hep.aida.ref.histogram
 
Histogram(String, String, int, String) - Constructor for class hep.aida.ref.histogram.Histogram
Create a new Histogram.
Histogram() - Constructor for class hep.aida.ref.histogram.Histogram
 
Histogram1D - Class in cern.hep.aida.ref
A reference implementation of hep.aida.IHistogram1D.
Histogram1D(String, double[]) - Constructor for class cern.hep.aida.ref.Histogram1D
Creates a variable-width histogram.
Histogram1D(String, int, double, double) - Constructor for class cern.hep.aida.ref.Histogram1D
Creates a fixed-width histogram.
Histogram1D(String, IAxis) - Constructor for class cern.hep.aida.ref.Histogram1D
Creates a histogram with the given axis binning.
Histogram1D - Class in hep.aida.ref.histogram
 
Histogram1D() - Constructor for class hep.aida.ref.histogram.Histogram1D
Create a 1-dimensional Histogram.
Histogram1D(String, String, IAxis) - Constructor for class hep.aida.ref.histogram.Histogram1D
Create a 1-dimensional Histogram.
Histogram2D - Class in cern.hep.aida.ref
A reference implementation of hep.aida.IHistogram2D.
Histogram2D(String, double[], double[]) - Constructor for class cern.hep.aida.ref.Histogram2D
Creates a variable-width histogram.
Histogram2D(String, int, double, double, int, double, double) - Constructor for class cern.hep.aida.ref.Histogram2D
Creates a fixed-width histogram.
Histogram2D(String, IAxis, IAxis) - Constructor for class cern.hep.aida.ref.Histogram2D
Creates a histogram with the given axis binning.
Histogram2D - Class in hep.aida.ref.histogram
 
Histogram2D() - Constructor for class hep.aida.ref.histogram.Histogram2D
Create a 2-dimensional Histogram.
Histogram2D(String, String, IAxis, IAxis) - Constructor for class hep.aida.ref.histogram.Histogram2D
Create a 2-dimensional Histogram.
Histogram3D - Class in cern.hep.aida.ref
A reference implementation of hep.aida.IHistogram3D.
Histogram3D(String, double[], double[], double[]) - Constructor for class cern.hep.aida.ref.Histogram3D
Creates a variable-width histogram.
Histogram3D(String, int, double, double, int, double, double, int, double, double) - Constructor for class cern.hep.aida.ref.Histogram3D
Creates a fixed-width histogram.
Histogram3D(String, IAxis, IAxis, IAxis) - Constructor for class cern.hep.aida.ref.Histogram3D
Creates a histogram with the given axis binning.
Histogram3D - Class in hep.aida.ref.histogram
 
Histogram3D() - Constructor for class hep.aida.ref.histogram.Histogram3D
Create a 3-dimensional Histogram.
Histogram3D(String, String, IAxis, IAxis, IAxis) - Constructor for class hep.aida.ref.histogram.Histogram3D
Create a 3-dimensional Histogram.
Histogram3D(String, String, IAxis, IAxis, IAxis, String) - Constructor for class hep.aida.ref.histogram.Histogram3D
Create a 3-dimensional Histogram.
histogramBins(double[], double, double, double) - Static method in class flanagan.analysis.Regression
 
histogramBins(double[], double, double) - Static method in class flanagan.analysis.Regression
 
histogramBins(double[], double) - Static method in class flanagan.analysis.Regression
 
histogramBins(double[], double, double, double) - Static method in class flanagan.analysis.Stat
 
histogramBins(double[], double, double) - Static method in class flanagan.analysis.Stat
 
histogramBins(double[], double) - Static method in class flanagan.analysis.Stat
 
histogramBinsPlot(double[], double, double, double) - Static method in class flanagan.analysis.Stat
 
histogramBinsPlot(double[], double, double, double, String) - Static method in class flanagan.analysis.Stat
 
histogramBinsPlot(double[], double, double) - Static method in class flanagan.analysis.Stat
 
histogramBinsPlot(double[], double, double, String) - Static method in class flanagan.analysis.Stat
 
histogramBinsPlot(double[], double) - Static method in class flanagan.analysis.Stat
 
histogramBinsPlot(double[], double, String) - Static method in class flanagan.analysis.Stat
 
HistogramChart - Class in umontreal.iro.lecuyer.charts
This class provides tools to create and manage histograms.
HistogramChart() - Constructor for class umontreal.iro.lecuyer.charts.HistogramChart
Initializes a new HistogramChart instance with an empty data set.
HistogramChart(String, String, String, double[]...) - Constructor for class umontreal.iro.lecuyer.charts.HistogramChart
Initializes a new HistogramChart instance with input data.
HistogramChart(String, String, String, double[], int) - Constructor for class umontreal.iro.lecuyer.charts.HistogramChart
Initializes a new HistogramChart instance with input data.
HistogramChart(String, String, String, DoubleArrayList...) - Constructor for class umontreal.iro.lecuyer.charts.HistogramChart
Initializes a new HistogramChart instance with data data.
HistogramChart(String, String, String, TallyStore...) - Constructor for class umontreal.iro.lecuyer.charts.HistogramChart
Initializes a new HistogramChart instance with data arrays contained in each TallyStore object.
HistogramChart(String, String, String, CustomHistogramDataset) - Constructor for class umontreal.iro.lecuyer.charts.HistogramChart
Initializes a new HistogramChart instance with data data.
HistogramChart(String, String, String, int[], double[]) - Constructor for class umontreal.iro.lecuyer.charts.HistogramChart
Initializes a new HistogramChart instance with data count and bound.
HistogramEvent - Class in hep.aida.ref.event
An event send from a Histogram to AIDAListeners
HistogramEvent(IBaseHistogram) - Constructor for class hep.aida.ref.event.HistogramEvent
 
HistogramFactory - Class in hep.aida.ref.histogram
 
HistogramFactory(ITree) - Constructor for class hep.aida.ref.histogram.HistogramFactory
Create a new HistogramFactory.
HistogramFactory(Tree) - Constructor for class hep.aida.ref.histogram.HistogramFactory
Create a new HistogramFactory.
histogramNormalization(IHistogram1D) - Static method in class hep.aida.ref.histogram.HistUtils
 
HistogramSeriesCollection - Class in umontreal.iro.lecuyer.charts
Stores data used in a HistogramChart.
HistogramSeriesCollection() - Constructor for class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Creates a new HistogramSeriesCollection instance with empty dataset.
HistogramSeriesCollection(double[]...) - Constructor for class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Creates a new HistogramSeriesCollection instance with given data series.
HistogramSeriesCollection(double[], int) - Constructor for class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Creates a new HistogramSeriesCollection instance with the given data series data.
HistogramSeriesCollection(DoubleArrayList...) - Constructor for class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Creates a new HistogramSeriesCollection.
HistogramSeriesCollection(TallyStore...) - Constructor for class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Creates a new HistogramSeriesCollection instance with default parameters and given data.
HistogramSeriesCollection(CustomHistogramDataset) - Constructor for class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Creates a new HistogramSeriesCollection instance.
HistUtils - Class in hep.aida.ref.histogram
 
HistUtils() - Constructor for class hep.aida.ref.histogram.HistUtils
 
HKey - Class in jhplot
Create an interactive key label in the USER or NDC coordinates.
HKey(String, Font, Color) - Constructor for class jhplot.HKey
Create a key label.
HKey(String, Font) - Constructor for class jhplot.HKey
Make a key label (color- black)
HKey(String) - Constructor for class jhplot.HKey
Make a key label with default attributes
HKey(String, double, double) - Constructor for class jhplot.HKey
Make a key label with specific coordinated in the data system
HKey(String, double, double, String) - Constructor for class jhplot.HKey
Make a label with specific coordinates.
HLabel - Class in jhplot
Create an interactive Label in the USER or NDC coordinates.
HLabel(String, Font, Color) - Constructor for class jhplot.HLabel
Make a text label
HLabel(String, Font) - Constructor for class jhplot.HLabel
Make a label (color- black)
HLabel(String) - Constructor for class jhplot.HLabel
Make a label with default attributes
HLabel(String, double, double) - Constructor for class jhplot.HLabel
Make a label with specific coordinated in the data system
HLabel(String, double, double, String) - Constructor for class jhplot.HLabel
Make a label with specific coordinates.
HLabelEq - Class in jhplot
Create an equation using the LaTex syntax.
HLabelEq(String, int, Color) - Constructor for class jhplot.HLabelEq
Make a label with equation using the LaTeX syntax
HLabelEq(String, int) - Constructor for class jhplot.HLabelEq
Make a equation label (color- black)
HLabelEq(String) - Constructor for class jhplot.HLabelEq
Make a label with default attributes
HLabelEq(String, double, double) - Constructor for class jhplot.HLabelEq
Make a equation label with specific coordinated in the data system
HLabelEq(String, double, double, String) - Constructor for class jhplot.HLabelEq
Make a label with specific coordinates.
HMLabel - Class in jhplot
Create an interactive multi-line label in the USER or NDC coordinates.
HMLabel(String[], Font, Color) - Constructor for class jhplot.HMLabel
Make a multitext label
HMLabel(String[], Font) - Constructor for class jhplot.HMLabel
Make a multitext label (black color is used).
HMLabel(String[]) - Constructor for class jhplot.HMLabel
Make a multitext label with default attributes.
HMLabel(String[], double, double) - Constructor for class jhplot.HMLabel
Make a label with specific coordinated in the data system
HMLabel(String[], double, double, String) - Constructor for class jhplot.HMLabel
Make a label with specific coordinates.
HNeuralNet - Class in jhplot
Neural net calculations.
HNeuralNet() - Constructor for class jhplot.HNeuralNet
Create a network net and set name for the network
holocaustMemorialDay() - Method in class flanagan.math.TimeAndDate
 
holocaustMemorialDay(int) - Method in class flanagan.math.TimeAndDate
 
homoscedasticT(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
homoscedasticT(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
homoscedasticT(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a 2-sample t statistic, under the hypothesis of equal subpopulation variances.
homoscedasticT(StatisticalSummary, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a 2-sample t statistic, comparing the means of the datasets described by two StatisticalSummary instances, under the assumption of equal subpopulation variances.
homoscedasticT(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a 2-sample t statistic, under the hypothesis of equal subpopulation variances.
homoscedasticT(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a 2-sample t statistic, comparing the means of the datasets described by two StatisticalSummary instances, under the assumption of equal subpopulation variances.
homoscedasticTTest(double[], double[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
homoscedasticTTest(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
homoscedasticTTest(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays, under the assumption that the two samples are drawn from subpopulations with equal variances.
homoscedasticTTest(double[], double[], double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha, assuming that the subpopulation variances are equal.
homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances, under the hypothesis of equal subpopulation variances.
homoscedasticTTest(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays, under the assumption that the two samples are drawn from subpopulations with equal variances.
homoscedasticTTest(double[], double[], double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha, assuming that the subpopulation variances are equal.
homoscedasticTTest(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances, under the hypothesis of equal subpopulation variances.
horizontalSum() - Method in class jhplot.bsom.Matrix
Make a horizontal-summation vector.
HPlot - Class in jhplot
HPlot class to create a canvas with several plots.
HPlot(String, int, int, int, int, boolean) - Constructor for class jhplot.HPlot
Create HPlot canvas with several plots.
HPlot(String, int, int, int, int) - Constructor for class jhplot.HPlot
Create HPlot canvas with several plots.
HPlot(String, int, int) - Constructor for class jhplot.HPlot
Construct a HPlot canvas with a single plot.
HPlot(String, int, int, boolean) - Constructor for class jhplot.HPlot
Construct a HPlot canvas with a single plot.
HPlot(String) - Constructor for class jhplot.HPlot
Construct a HPlot canvas with a plot with the size 600x400.
HPlot() - Constructor for class jhplot.HPlot
Construct a HPlot canvas with a single plot with the size 600x400.
HPlot2D - Class in jhplot
A class to build a contour (density) plots in 2D.
HPlot2D(String, int, int, int, int, boolean) - Constructor for class jhplot.HPlot2D
Create canvas with a several plots
HPlot2D(String, int, int) - Constructor for class jhplot.HPlot2D
Construct a HChart canvas with a single plot/graph
HPlot2D(String, int, int, boolean) - Constructor for class jhplot.HPlot2D
Construct a HChart canvas with a single plot/graph
HPlot2D(String, int, int, int, int) - Constructor for class jhplot.HPlot2D
Construct a HChart canvas with plots/graphs
HPlot2D(String) - Constructor for class jhplot.HPlot2D
Construct a HChart canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
HPlot2D() - Constructor for class jhplot.HPlot2D
Construct a HChart canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default"
HPlot3D - Class in jhplot
Create a interactive canvas to show objects in 3D.
HPlot3D(String, int, int, int, int, boolean) - Constructor for class jhplot.HPlot3D
Create a canvas to display histograms in 3D
HPlot3D(String, int, int, int, int) - Constructor for class jhplot.HPlot3D
Create a canvas to display histograms in 3D
HPlot3D(String, int, int) - Constructor for class jhplot.HPlot3D
Construct a HView2D canvas with a single plot/graph
HPlot3D(String) - Constructor for class jhplot.HPlot3D
Construct a HGraph canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
HPlot3D() - Constructor for class jhplot.HPlot3D
Construct a HGraph canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default"
HPlot3DP - Class in jhplot
Create a frame for showing 3D parametric functions.
HPlot3DP(String, int, int, int, int, boolean) - Constructor for class jhplot.HPlot3DP
Create a canvas with several plots showing 3D function
HPlot3DP(String, int, int) - Constructor for class jhplot.HPlot3DP
Construct a canvas with a single plot/graph
HPlot3DP(String, int, int, int, int) - Constructor for class jhplot.HPlot3DP
Construct a canvas with plots/graphs
HPlot3DP(String) - Constructor for class jhplot.HPlot3DP
Construct a canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
HPlot3DP() - Constructor for class jhplot.HPlot3DP
Construct a canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default"
HPlotJa - Class in jhplot
A canvas to display all graphical objects including Feynman diagrams.
HPlotJa(String, int, int, int, int, boolean) - Constructor for class jhplot.HPlotJa
Create HPlotJa canvas with several pads.
HPlotJa(String, int, int, int, int) - Constructor for class jhplot.HPlotJa
Create HPlotJa canvas with several pads and axes.
HPlotJa(String, int, int) - Constructor for class jhplot.HPlotJa
Construct a japlot.jaxodraw with a single plot/graph.
HPlotJa(String) - Constructor for class jhplot.HPlotJa
Construct a japlot.jaxodraw canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
HPlotJa() - Constructor for class jhplot.HPlotJa
Default constructor
HProf1D - Class in jhplot
Create profile histogram in 1D.
HProf1D() - Constructor for class jhplot.HProf1D
Build 1D histogram.
HProf1D(String, int, double, double) - Constructor for class jhplot.HProf1D
Build 1D profile histogram
HProf1D(String, double[]) - Constructor for class jhplot.HProf1D
Create 1D profile histogram with variable bin size.
HProf1D(String, IAxis) - Constructor for class jhplot.HProf1D
Create 1D histogram with variable bin size.
HProf1D(Profile1D) - Constructor for class jhplot.HProf1D
Create H1D histogram from JAIDA Histogram1D class.
HProf1D(IProfile1D) - Constructor for class jhplot.HProf1D
Create profile histogram from JAIDA class
HProf1D(String, HProf1D) - Constructor for class jhplot.HProf1D
Create profile histogram from another instance.
HProf1D(TProfile) - Constructor for class jhplot.HProf1D
Create profile histogram from JAIDA histogram class
HProf2D - Class in jhplot
Profile histogram in 2D.
HProf2D(String, int, double, double, int, double, double) - Constructor for class jhplot.HProf2D
Create 2D histogram
HProf2D(String, double[], double[]) - Constructor for class jhplot.HProf2D
Create 2D profile histogram with variable bin size.
HProf2D(Profile2D) - Constructor for class jhplot.HProf2D
Create a H2D histogram from JAIDA histogram
HShape - Class in jhplot.shapes
Main class to build a JAVA 2D primitives
HShape(double, double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.HShape
Build a primitive
HShape() - Constructor for class jhplot.shapes.HShape
Build a default primitive
HShape(double, double, double, double) - Constructor for class jhplot.shapes.HShape
Build a primitive using the default color and stroke
HShape(double[], double[], Stroke, Color) - Constructor for class jhplot.shapes.HShape
Build a primitive using polyline.
HTable - Class in jhplot
Build a table in a frame to display data in various containers (P1D, H1D, F1D).
HTable(String, Vector<String>, Vector) - Constructor for class jhplot.HTable
Main class to build a table from Vectors.
HTable() - Constructor for class jhplot.HTable
Build a table frame to display data.
HTable(H1D) - Constructor for class jhplot.HTable
Build a table frame to display data of H1D histogram Data will be formated to scientific format
HTable(F1D) - Constructor for class jhplot.HTable
Build a table frame to display data of F1D function Data will be formated to scientific format
HTable(DataHolder) - Constructor for class jhplot.HTable
Build a table frame to display multidimensional data holder.
HTable(P0D) - Constructor for class jhplot.HTable
Build a table frame to display P0D data container Data will be formated to scientific format
HTable(P0I) - Constructor for class jhplot.HTable
Build a table frame to display P0D data container Data will be formated to scientific format
HTable(P1D) - Constructor for class jhplot.HTable
Build a table frame to display P1D data container Data will be formated to scientific format
HTable(P2D) - Constructor for class jhplot.HTable
Build a table frame to display P2D data container Data will be formated to scientific format
HTable(P3D) - Constructor for class jhplot.HTable
Build a table frame to display P3D data container Data will be formated to scientific format
HTable(H1D, boolean) - Constructor for class jhplot.HTable
Build a table frame to display data of H1D histogram
HTable(F1D, boolean) - Constructor for class jhplot.HTable
Build a table frame to display data of F1D function.
HTable(DataHolder, boolean) - Constructor for class jhplot.HTable
Build a table frame to display multidimensional data
HTable(P1D, boolean) - Constructor for class jhplot.HTable
Build a table frame to display P1D data container
HTable(P0D, boolean) - Constructor for class jhplot.HTable
Build a table frame to display P0D data container
HTable(P0I, boolean) - Constructor for class jhplot.HTable
Build a table frame to display P0D data container
HTable(P2D, boolean) - Constructor for class jhplot.HTable
Build a table frame to display P2D data container
HTable(P3D, boolean) - Constructor for class jhplot.HTable
Build a table frame to display P3D data container
htmlEncoded(String) - Static method in class jhplot.v3d.Util
Substitutes conflicting characters in text with html masked expressions.
HView3D - Class in jhplot
Create a frame for showing 3D objects
HView3D(String, int, int, int, int, boolean) - Constructor for class jhplot.HView3D
Create a HView3D canvas with several plots showing 3D shapes
HView3D(String, int, int) - Constructor for class jhplot.HView3D
Construct a HView3D canvas with a single plot/graph
HView3D(String, int, int, boolean) - Constructor for class jhplot.HView3D
Construct a HView3D canvas with a single plot/graph
HView3D(String, int, int, int, int) - Constructor for class jhplot.HView3D
Construct a HView3D canvas with plots/graphs
HView3D(String) - Constructor for class jhplot.HView3D
Construct a HGraph canvas with a plot with the default parameters 600 by 400, and 10% space for the global title
HView3D() - Constructor for class jhplot.HView3D
Construct a HGraph canvas with a plot with the default parameters 600 by 400, and 10% space for the global title "Default"
HyBRDoubleIterationMonitor - Class in cern.colt.matrix.tdouble.algo.solver
 
HyBRDoubleIterationMonitor() - Constructor for class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
Constructor for HyBRDoubleIterationMonitor.
HyBRDoubleIterationMonitor(int, double) - Constructor for class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
Constructor for HyBRDoubleIterationMonitor
HyBRFloatIterationMonitor - Class in cern.colt.matrix.tfloat.algo.solver
 
HyBRFloatIterationMonitor() - Constructor for class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
Constructor for HyBRFloatIterationMonitor.
HyBRFloatIterationMonitor(int, float) - Constructor for class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
Constructor for HyBRFloatIterationMonitor
HyBRInnerSolver - Enum in cern.colt.matrix.tdouble.algo.solver
 
HyBRRegularizationMethod - Enum in cern.colt.matrix.tdouble.algo.solver
 
Hyperbolic - Class in cern.jet.random
Hyperbolic distribution.
Hyperbolic(double, double, RandomEngine) - Constructor for class cern.jet.random.Hyperbolic
Constructs a Beta distribution.
Hyperbolic - Class in cern.jet.random.tdouble
Hyperbolic distribution.
Hyperbolic(double, double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.Hyperbolic
Constructs a Beta distribution.
HyperbolicSecantDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Hyperbolic Secant distribution with location parameter μ and scale parameter σ > 0.
HyperbolicSecantDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Constructs a hyperbolic secant distribution with parameters μ and σ.
HyperbolicSecantGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the hyperbolic secant distribution with location parameter μ and scale parameter σ.
HyperbolicSecantGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.HyperbolicSecantGen
Creates a hyperbolic secant random variate generator with parameters μ = mu and σ = sigma, using stream s.
HyperbolicSecantGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.HyperbolicSecantGen
Creates a hyperbolic secant random variate generator with parameters μ = 0 and σ = 1, using stream s.
HyperbolicSecantGen(RandomStream, HyperbolicSecantDist) - Constructor for class umontreal.iro.lecuyer.randvar.HyperbolicSecantGen
Creates a new generator for the distribution dist, using stream s.
HyperGeometric - Class in cern.jet.random
HyperGeometric distribution; See the math definition The hypergeometric distribution with parameters N, n and s is the probability distribution of the random variable X, whose value is the number of successes in a sample of n items from a population of size N that has s 'success' items and N - s 'failure' items.
HyperGeometric(int, int, int, RandomEngine) - Constructor for class cern.jet.random.HyperGeometric
Constructs a HyperGeometric distribution.
HyperGeometric - Class in cern.jet.random.tdouble
HyperGeometric distribution; See the math definition The hypergeometric distribution with parameters N, n and s is the probability distribution of the random variable X, whose value is the number of successes in a sample of n items from a population of size N that has s 'success' items and N - s 'failure' items.
HyperGeometric(int, int, int, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.HyperGeometric
Constructs a HyperGeometric distribution.
Hypergeometric - Class in jhplot.math.num.pdf
The Hypergeometric distribution.
Hypergeometric() - Constructor for class jhplot.math.num.pdf.Hypergeometric
Default constructor.
Hypergeometric(int, int, int) - Constructor for class jhplot.math.num.pdf.Hypergeometric
Create a distribution with the given number of failures, number of successes, and sample size.
HypergeometricDist - Class in umontreal.iro.lecuyer.probdist
Extends the class DiscreteDistributionInt for the hypergeometric distribution with k elements chosen among l, m being of one type, and l - m of the other.
HypergeometricDist(int, int, int) - Constructor for class umontreal.iro.lecuyer.probdist.HypergeometricDist
Constructs an hypergeometric distribution with parameters m, l and k.
HypergeometricDistribution - Interface in org.apache.commons.math.distribution
The Hypergeometric Distribution.
HypergeometricDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of HypergeometricDistribution.
HypergeometricDistributionImpl(int, int, int) - Constructor for class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Construct a new hypergeometric distribution with the given the population size, the number of successes in the population, and the sample size.
HypergeometricGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the hypergeometric distribution.
HypergeometricGen(RandomStream, int, int, int) - Constructor for class umontreal.iro.lecuyer.randvar.HypergeometricGen
Creates a hypergeometric generator with parameters m = m, l = l and k = k, using stream s.
HypergeometricGen(RandomStream, HypergeometricDist) - Constructor for class umontreal.iro.lecuyer.randvar.HypergeometricGen
Creates a new generator for distribution dist, using stream s.
hypot(double, double) - Static method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns sqrt(a^2 + b^2) without under/overflow.
hypot(float, float) - Static method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns sqrt(a^2 + b^2) without under/overflow.
hypot(ErrorProp, ErrorProp, double) - Static method in class flanagan.analysis.ErrorProp
 
hypot(ErrorProp, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
hypot(double, double) - Static method in class flanagan.math.Fmath
 
hypot(float, float) - Static method in class flanagan.math.Fmath
 
hypot(double, double) - Static method in class jhplot.math.Mathfun
sqrt(a^2 + b^2) without under/overflow.
hypot(ValueErr, ValueErr) - Static method in class jhplot.math.ValueErr
Returns the length of the hypotenuse of a and b i.e.
hypot(double, double) - Static method in class org.apache.commons.math.util.FastMath
Returns the hypotenuse of a triangle with sides x and y - sqrt(x2 +y2)
avoiding intermediate overflow or underflow.
hypotenuse(ValueErr, ValueErr, double) - Static method in class jhplot.math.ValueErr
Returns the length of the hypotenuse of a and b i.e.
hypotenuse(double, double) - Static method in class jhplot.math.ValueErr
Returns the length of the hypotenuse of a and b i.e.
hypotFunction() - Static method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns sqrt(a^2 + b^2) without under/overflow.
hypotFunction() - Static method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns sqrt(a^2 + b^2) without under/overflow.
HZirkel - Class in jhplot
HZirkel class is used to create a canvas for dynamic manipulation with geometrical objects.
HZirkel() - Constructor for class jhplot.HZirkel
Build a canvas for the zirkel with the standard size 600x600
HZirkel(int, int) - Constructor for class jhplot.HZirkel
Build a canvas for the Zirkel canvas

I

I - Static variable in class org.apache.commons.math.complex.Complex
The square root of -1.
i0(double) - Static method in class cern.jet.math.Bessel
Returns the modified Bessel function of order 0 of the argument.
i0(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the modified Bessel function of order 0 of the argument.
i0e(double) - Static method in class cern.jet.math.Bessel
Returns the exponentially scaled modified Bessel function of order 0 of the argument.
i0e(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the exponentially scaled modified Bessel function of order 0 of the argument.
i1(double) - Static method in class cern.jet.math.Bessel
Returns the modified Bessel function of order 1 of the argument.
i1(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the modified Bessel function of order 1 of the argument.
i1e(double) - Static method in class cern.jet.math.Bessel
Returns the exponentially scaled modified Bessel function of order 1 of the argument.
i1e(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the exponentially scaled modified Bessel function of order 1 of the argument.
iBinomialMatrixScramble(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Applies the i-binomial matrix scramble proposed by Tezuka .
iBinomialMatrixScramble(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
iBinomialMatrixScrambleFaurePermut(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Similar to iBinomialMatrixScramble except that the diagonal elements of each matrix Mj are chosen as in leftMatrixScrambleFaurePermut.
iBinomialMatrixScrambleFaurePermut(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
iBinomialMatrixScrambleFaurePermutAll(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Similar to iBinomialMatrixScrambleFaurePermut except that the elements under the diagonal are also chosen from the same restricted set as the diagonal elements.
iBinomialMatrixScrambleFaurePermutAll(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
iBinomialMatrixScrambleFaurePermutDiag(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Similar to iBinomialMatrixScrambleFaurePermut except that all the off-diagonal elements are 0.
iBinomialMatrixScrambleFaurePermutDiag(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
icnteq(int, int[], int) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
icopy(int, int[], int, int[], int) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
idamax(DoubleMatrix1D) - Method in interface cern.colt.matrix.linalg.Blas
Returns the index of largest absolute value; i such that |x[i]| == max(|x[0]|,|x[1]|,...)..
idamax(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SeqBlas
 
idamax(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.SmpBlas
 
idamax(DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.DoubleBlas
Returns the index of largest absolute value; i such that |x[i]| == max(|x[0]|,|x[1]|,...)..
idamax(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
idamax(FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.FloatBlas
Returns the index of largest absolute value; i such that |x[i]| == max(|x[0]|,|x[1]|,...)..
idamax(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
idamax(int, double[], int) - Method in class org.netlib.blas.BLAS
..
idct(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Computes the inverse of the discrete cosine transform (DCT-III) of this matrix.
idct(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Computes the inverse of the discrete cosine transform (DCT-III) of this matrix.
idct2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct2(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct2(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of each slice of this matrix.
idct2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of each slice of this matrix.
idct2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of each slice of this matrix.
idct2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of each slice of this matrix.
idct2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of each slice of this matrix.
idct2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 2D inverse of the discrete cosine transform (DCT-III) of each slice of this matrix.
idct3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 3D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 3D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct3(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 3D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 3D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 3D inverse of the discrete cosine transform (DCT-III) of this matrix.
idct3(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 3D inverse of the discrete cosine transform (DCT-III) of this matrix.
idctColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each column of this matrix.
idctColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each column of this matrix.
idctColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each column of this matrix.
idctColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each column of this matrix.
idctColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each column of this matrix.
idctColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each column of this matrix.
idctColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each column of this matrix.
idctColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each column of this matrix.
idctRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each row of this matrix.
idctRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each row of this matrix.
idctRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each row of this matrix.
idctRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each row of this matrix.
idctRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each row of this matrix.
idctRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each row of this matrix.
idctRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each row of this matrix.
idctRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the inverse of the discrete cosine transform (DCT-III) of each row of this matrix.
identity(int) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs an identity matrix (having ones on the diagonal and zeros elsewhere).
identity(int) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs an identity matrix (having ones on the diagonal and zeros elsewhere).
identity(int) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs an identity matrix (having ones on the diagonal and zeros elsewhere).
identity(int) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs an identity matrix (having ones on the diagonal and zeros elsewhere).
identity(int) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs an identity matrix (having ones on the diagonal and zeros elsewhere).
identity(int) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs an identity matrix (having ones on the diagonal and zeros elsewhere).
identity(int) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs an identity matrix (having ones on the diagonal and zeros elsewhere).
identity - Static variable in class cern.jet.math.Functions
Function that returns its argument.
identity - Static variable in class cern.jet.math.IntFunctions
Function that returns its argument.
identity - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
identity - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns its argument.
identity - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
identity - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns its argument.
identity - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns its argument.
identity - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns its argument.
identity() - Static method in class hephysics.vec.Hep3Matrix
 
identity(int) - Static method in class jhplot.bsom.Matrix
Make an identity matrix.
identity(int) - Static method in class jhplot.math.DoubleArray
Generates an m x m identity matrix.
identity(int) - Static method in class jhplot.math.SortUtils
Create identity permutation, that is {0, 1, ..., n}
IDENTITY - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The identity function.
IDENTITY - Static variable in class org.apache.commons.math.geometry.Rotation
Identity rotation.
IdentityMathFunction - Class in umontreal.iro.lecuyer.functions
Represents the identity function f (x) = x.
IdentityMathFunction() - Constructor for class umontreal.iro.lecuyer.functions.IdentityMathFunction
 
identityMatrix(int) - Static method in class flanagan.math.Matrix
 
identityPermutation(int) - Static method in class org.apache.commons.math.genetics.RandomKey
Generates a representation corresponding to an identity permutation of length l which can be passed to the RandomKey constructor.
idht(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Computes the inverse of the discrete Hartley transform (IDHT) of this matrix.
idht(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Computes the inverse of the discrete Hartley transform (IDHT) of this matrix.
idht2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the 2D inverse of the discrete Hartley transform (IDHT) of this matrix.
idht2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the 2D inverse of the discrete Hartley transform (IDHT) of this matrix.
idht2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the 2D inverse of the discrete Hartley transform (IDHT) of this matrix.
idht2(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the 2D inverse of the discrete Hartley transform (DHT) of this matrix.
idht2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the 2D inverse of the discrete Hartley transform (IDHT) of this matrix.
idht2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the 2D inverse of the discrete Hartley transform (IDHT) of this matrix.
idht2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the 2D inverse of the discrete Hartley transform (IDHT) of this matrix.
idht2(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the 2D inverse of the discrete Hartley transform (DHT) of this matrix.
idht2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 2D inverse of the discrete Hartley transform (IDHT) of each slice of this matrix.
idht2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 2D inverse of the discrete Hartley transform (IDHT) of each slice of this matrix.
idht2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 2D inverse of the discrete Hartley transform (DHT) of each slice of this matrix.
idht2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 2D inverse of the discrete Hartley transform (IDHT) of each slice of this matrix.
idht2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 2D inverse of the discrete Hartley transform (IDHT) of each slice of this matrix.
idht2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 2D inverse of the discrete Hartley transform (DHT) of each slice of this matrix.
idht3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 3D inverse of the discrete Hartley transform (IDHT) of this matrix.
idht3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 3D inverse of the discrete Hartley transform (IDHT) of this matrix.
idht3(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 3D inverse of the discrete Hartley transform (DHT) of this matrix.
idht3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 3D inverse of the discrete Hartley transform (IDHT) of this matrix.
idht3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 3D inverse of the discrete Hartley transform (IDHT) of this matrix.
idht3(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 3D inverse of the discrete Hartley transform (DHT) of this matrix.
idhtColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each column of this matrix.
idhtColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each column of this matrix.
idhtColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each column of this matrix.
idhtColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the inverse of the discrete Hartley transform (DHT) of each column of this matrix.
idhtColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each column of this matrix.
idhtColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each column of this matrix.
idhtColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each column of this matrix.
idhtColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the inverse of the discrete Hartley transform (DHT) of each column of this matrix.
idhtRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each row of this matrix.
idhtRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each row of this matrix.
idhtRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each row of this matrix.
idhtRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the inverse of the discrete Hartley transform (DHT) of each row of this matrix.
idhtRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each row of this matrix.
idhtRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each row of this matrix.
idhtRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the inverse of the discrete Hartley transform (IDHT) of each row of this matrix.
idhtRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the inverse of the discrete Hartley transform (DHT) of each row of this matrix.
idst(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Computes the inverse of discrete sine transform (DST-III) of this matrix.
idst(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Computes the inverse of discrete sine transform (DST-III) of this matrix.
idst2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the 2D inverse of the discrete sine transform (DST-III) of this matrix.
idst2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the 2D inverse of the discrete sine transform (DST-III) of this matrix.
idst2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the 2D inverse of the discrete sine transform (DST-III) of this matrix.
idst2(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the 2D inverse of the discrete size transform (DST-III) of this matrix.
idst2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the 2D inverse of the discrete sine transform (DST-III) of this matrix.
idst2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the 2D inverse of the discrete sine transform (DST-III) of this matrix.
idst2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the 2D inverse of the discrete sine transform (DST-III) of this matrix.
idst2(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the 2D inverse of the discrete size transform (DST-III) of this matrix.
idst2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 2D inverse of the discrete sine transform (DST-III) of each slice of this matrix.
idst2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 2D inverse of the discrete sine transform (DST-III) of each slice of this matrix.
idst2Slices(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 2D inverse of the discrete sine transform (DST-III) of each slice of this matrix.
idst2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 2D inverse of the discrete sine transform (DST-III) of each slice of this matrix.
idst2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 2D inverse of the discrete sine transform (DST-III) of each slice of this matrix.
idst2Slices(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 2D inverse of the discrete sine transform (DST-III) of each slice of this matrix.
idst3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 3D inverse of the discrete sine transform (DST-III) of this matrix.
idst3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 3D inverse of the discrete sine transform (DST-III) of this matrix.
idst3(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 3D inverse of the discrete size transform (DST-III) of this matrix.
idst3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 3D inverse of the discrete sine transform (DST-III) of this matrix.
idst3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 3D inverse of the discrete sine transform (DST-III) of this matrix.
idst3(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 3D inverse of the discrete size transform (DST-III) of this matrix.
idstColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each column of this matrix.
idstColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each column of this matrix.
idstColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each column of this matrix.
idstColumns(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each column of this matrix.
idstColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each column of this matrix.
idstColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each column of this matrix.
idstColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each column of this matrix.
idstColumns(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each column of this matrix.
idstRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each row of this matrix.
idstRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each row of this matrix.
idstRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each row of this matrix.
idstRows(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each row of this matrix.
idstRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each row of this matrix.
idstRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each row of this matrix.
idstRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each row of this matrix.
idstRows(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the inverse of the discrete sine transform (DST-III) of each row of this matrix.
IEditor - Class in jhplot
Advanced image editor for PNG, JPG, GIF files (based on ImageJ)
IEditor() - Constructor for class jhplot.IEditor
Show an empty image viewer.
IEditor(String) - Constructor for class jhplot.IEditor
Start image editor and load an image.
ieeeck(int, float, float) - Method in class org.netlib.lapack.LAPACK
..
IEEEremainder - Static variable in class cern.jet.math.Functions
Function that returns Math.IEEEremainder(a,b).
IEEEremainder(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns Math.IEEEremainder(a,b).
IEEEremainder - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.IEEEremainder(a,b).
IEEEremainder(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns Math.IEEEremainder(a,b).
IEEEremainder - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.IEEEremainder(a,b).
IEEEremainder(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns Math.IEEEremainder(a,b).
IEEEremainder(double, double) - Static method in class org.apache.commons.math.util.FastMath
Computes the remainder as prescribed by the IEEE 754 standard.
ifft(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
Computes the inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
Computes the inverse of the discrete Fourier transform (DFT) of this matrix.
ifft(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
Computes the inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
Computes the inverse of the discrete Fourier transform (DFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft2Slices(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
ifft2Slices(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix3D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
ifft2Slices(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
ifft2Slices(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
ifft2Slices(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix3D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
ifft2Slices(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
Computes the 2D inverse of the discrete Fourier transform (IDFT) of each slice of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifft3(boolean) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
Computes the 3D inverse of the discrete Fourier transform (IDFT) of this matrix.
ifftColumns(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
ifftColumns(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
ifftColumns(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
ifftColumns(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
Computes the inverse of the discrete Fourier transform (DFT) of each column of this matrix.
ifftColumns(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
ifftColumns(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
ifftColumns(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each column of this matrix.
ifftColumns(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
Computes the inverse of the discrete Fourier transform (DFT) of each column of this matrix.
ifftRows(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
ifftRows(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
ifftRows(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
ifftRows(boolean) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
Computes the inverse of the discrete Fourier transform (DFT) of each row of this matrix.
ifftRows(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
ifftRows(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
ifftRows(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
Computes the inverse of the discrete Fourier transform (IDFT) of each row of this matrix.
ifftRows(boolean) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
Computes the inverse of the discrete Fourier transform (DFT) of each row of this matrix.
IFunctionCoreNotNorm - Class in hep.aida.ref.function
Wrapper around ordinary IFunction
IFunctionCoreNotNorm(IFunction) - Constructor for class hep.aida.ref.function.IFunctionCoreNotNorm
 
IFunctionCoreNotNorm(IFunction, double[]) - Constructor for class hep.aida.ref.function.IFunctionCoreNotNorm
 
ignoreDofFcheck() - Method in class flanagan.analysis.Regression
 
ignoreMissingDataOptionRequests() - Method in class flanagan.analysis.Scores
 
IIDMultivariateGen - Class in umontreal.iro.lecuyer.randvarmulti
Extends RandomMultivariateGen for a vector of independent identically distributed (i.i.d.) random variables.
IIDMultivariateGen(RandomVariateGen, int) - Constructor for class umontreal.iro.lecuyer.randvarmulti.IIDMultivariateGen
Constructs a generator for a d-dimensional vector of i.i.d.
ilaenv(int, String, String, int, int, int, int) - Method in class org.netlib.lapack.LAPACK
..
ilaver(intW, intW, intW) - Method in class org.netlib.lapack.LAPACK
-- LAPACK routine (version 3.1.1) -- Univ.
ILN2 - Static variable in class umontreal.iro.lecuyer.util.Num
The values of 1/ln 2.
imag() - Method in class jhplot.math.Complex
Imaginary part of this Complex number (the y-coordinate in rectangular coordinates).
IMAGE - Static variable in class jhplot.shapes.HShape
 
immaculateConception() - Method in class flanagan.math.TimeAndDate
 
immaculateConception(int) - Method in class flanagan.math.TimeAndDate
 
inc - Static variable in class cern.jet.math.IntFunctions
Function that returns a++.
inc - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a++.
inc - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a++.
inchToMillimetre(double) - Static method in class flanagan.math.Conv
 
inchToMillimetre(double) - Static method in class flanagan.math.Fmath
 
include(double, double) - Method in class hep.aida.ref.function.RangeSet
Additive include/exclude of the range in given axis.
includeAll() - Method in class hep.aida.ref.function.RangeSet
Set full range in all axes.
includeNormalizationAll(int) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
includeNormalizationAll() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
includeNormalizationAll() - Method in class hep.aida.ref.function.AbstractIFunction
 
includeNormalizationAll() - Method in class hep.aida.ref.function.BaseModelFunction
 
includeNormalizationRange(double, double, int) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
incompleteBeta(double, double, double) - Static method in class cern.jet.stat.Gamma
Returns the Incomplete Beta Function evaluated from zero to xx; formerly named ibeta.
incompleteBeta(double, double, double) - Static method in class cern.jet.stat.tdouble.Gamma
Returns the Incomplete Beta Function evaluated from zero to xx; formerly named ibeta.
incompleteBeta(double, double, double) - Static method in class flanagan.analysis.Stat
 
incompleteGamma(double, double) - Static method in class cern.jet.stat.Gamma
Returns the Incomplete Gamma function; formerly named igamma.
incompleteGamma(double, double) - Static method in class cern.jet.stat.tdouble.Gamma
Returns the Incomplete Gamma function; formerly named igamma.
incompleteGamma(double, double) - Static method in class flanagan.analysis.Stat
 
incompleteGammaComplement(double, double) - Static method in class cern.jet.stat.Gamma
Returns the Complemented Incomplete Gamma function; formerly named igamc.
incompleteGammaComplement(double, double) - Static method in class cern.jet.stat.tdouble.Gamma
Returns the Complemented Incomplete Gamma function; formerly named igamc.
incompleteGammaComplementary(double, double) - Static method in class flanagan.analysis.Stat
 
incompleteGammaFract(double, double) - Static method in class flanagan.analysis.Stat
 
incompleteGammaSer(double, double) - Static method in class flanagan.analysis.Stat
 
increasedPrecis(boolean) - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated. After calling this method with incp = true, each call to the generator (direct or indirect) for this stream will return a uniform random number with (roughly) 53 bits of resolution instead of 32 bits, and will advance the state of the stream by 2 steps instead of 1.
increasedPrecision(boolean) - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
After calling this method with incp = true, each call to the RNG (direct or indirect) for this stream will return a uniform random number with more bits of precision than what is returned by nextValue, and will advance the state of the stream by 2 steps instead of 1 (i.e., nextValue will be called twice for each random number).
increment(int, int, double, double) - Static method in class jhplot.math.DoubleArray
Provides an mxn matrix.
increment(int, double, double) - Static method in class jhplot.math.DoubleArray
Provides a sequence of successive values in an array.
increment(int, int, double[], double[]) - Static method in class jhplot.math.DoubleArray
Generates an mxn matrix.
increment(double, double, double) - Static method in class jhplot.math.DoubleArray
Generates an array of successive values from begin to end with step size pitch.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.FirstMoment
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.FourthMoment
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.Mean
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.SecondMoment
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.Skewness
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Add a new vector to the sample.
increment(double[]) - Method in class org.apache.commons.math.stat.descriptive.moment.VectorialMean
Add a new vector to the sample.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.rank.Max
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.rank.Min
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.summary.Product
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.summary.Sum
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Updates the internal state of the statistic to reflect the addition of the new value.
increment(double) - Method in class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Updates the internal state of the statistic to reflect the addition of the new value.
incrementAll(double[]) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation just calls AbstractStorelessUnivariateStatistic.increment(double) in a loop over the input array.
incrementAll(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.AbstractStorelessUnivariateStatistic
This default implementation just calls AbstractStorelessUnivariateStatistic.increment(double) in a loop over the specified portion of the input array.
incrementAll(double[]) - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect addition of all values in the values array.
incrementAll(double[], int, int) - Method in interface org.apache.commons.math.stat.descriptive.StorelessUnivariateStatistic
Updates the internal state of the statistic to reflect addition of the values in the designated portion of the values array.
incrementalUpdate(DoubleArrayList, int, int, double[]) - Static method in class cern.jet.stat.Descriptive
Incrementally maintains and updates minimum, maximum, sum and sum of squares of a data sequence.
incrementalUpdate(DoubleArrayList, int, int, double[]) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Incrementally maintains and updates minimum, maximum, sum and sum of squares of a data sequence.
incrementalUpdate(FloatArrayList, int, int, float[]) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Incrementally maintains and updates minimum, maximum, sum and sum of squares of a data sequence.
incrementalUpdateSumsOfPowers(DoubleArrayList, int, int, int, int, double[]) - Static method in class cern.jet.stat.Descriptive
Incrementally maintains and updates various sums of powers of the form Sum(data[i]k).
incrementalUpdateSumsOfPowers(DoubleArrayList, int, int, int, int, double[]) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Incrementally maintains and updates various sums of powers of the form Sum(data[i]k).
incrementalUpdateSumsOfPowers(FloatArrayList, int, int, int, int, float[]) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Incrementally maintains and updates various sums of powers of the form Sum(data[i]k).
incrementalWeightedUpdate(DoubleArrayList, DoubleArrayList, int, int, double[]) - Static method in class cern.jet.stat.Descriptive
Incrementally maintains and updates sum and sum of squares of a weighted data sequence.
incrementalWeightedUpdate(DoubleArrayList, DoubleArrayList, int, int, double[]) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Incrementally maintains and updates sum and sum of squares of a weighted data sequence.
incrementalWeightedUpdate(FloatArrayList, FloatArrayList, int, int, float[]) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Incrementally maintains and updates sum and sum of squares of a weighted data sequence.
incrementElement(int, int, double) - Method in class hephysics.matrix.SymmetricMatrix
Increment a specific element
incRot(float, float, float) - Method in class jhplot.v3d.Position
 
incScale(float, float, float) - Method in class jhplot.v3d.Position
 
incTrans(float, float, float) - Method in class jhplot.v3d.Position
 
index(int) - Method in class cern.colt.matrix.AbstractMatrix1D
Returns the position of the element with the given relative rank within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int) - Method in class cern.colt.matrix.AbstractMatrix2D
Returns the position of the given coordinate within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int, int) - Method in class cern.colt.matrix.AbstractMatrix3D
Returns the position of the given coordinate within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
index(int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
index(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
index(int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
index(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
index(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
index(int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
index(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
index(int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Returns the position of the element with the given relative rank within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
index(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
index(int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
index(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
index(int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
index(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
index(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
index(int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
index(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
index(int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Returns the position of the element with the given relative rank within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
index(int, int) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
index(int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
index(int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
index(int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Returns the position of the element with the given relative rank within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
index(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
index(int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
index(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
index(int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Returns the position of the element with the given relative rank within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
index(int, int, int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
index(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
index(int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Returns the position of the element with the given relative rank within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Returns the position of the given coordinate within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int, int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
Returns the position of the given coordinate within the (virtual or non-virtual) internal 1-dimensional array.
index(int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Returns the position of the element with the given relative rank within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Returns the position of the given coordinate within the (virtual or non-virtual) internal 1-dimensional array.
index(int, int, int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Returns the position of the given coordinate within the (virtual or non-virtual) internal 1-dimensional array.
IndexFunction - Interface in jhplot.math
BSD License
indexOf(boolean) - Method in class cern.colt.list.AbstractBooleanList
Returns the index of the first occurrence of the specified element.
indexOf(byte) - Method in class cern.colt.list.AbstractByteList
Returns the index of the first occurrence of the specified element.
indexOf(char) - Method in class cern.colt.list.AbstractCharList
Returns the index of the first occurrence of the specified element.
indexOf(double) - Method in class cern.colt.list.AbstractDoubleList
Returns the index of the first occurrence of the specified element.
indexOf(float) - Method in class cern.colt.list.AbstractFloatList
Returns the index of the first occurrence of the specified element.
indexOf(int) - Method in class cern.colt.list.AbstractIntList
Returns the index of the first occurrence of the specified element.
indexOf(long) - Method in class cern.colt.list.AbstractLongList
Returns the index of the first occurrence of the specified element.
indexOf(short) - Method in class cern.colt.list.AbstractShortList
Returns the index of the first occurrence of the specified element.
indexOf(Object, boolean) - Method in class cern.colt.list.ObjectArrayList
Returns the index of the first occurrence of the specified element.
indexOf(boolean) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns the index of the first occurrence of the specified element.
indexOf(byte) - Method in class cern.colt.list.tbyte.AbstractByteList
Returns the index of the first occurrence of the specified element.
indexOf(char) - Method in class cern.colt.list.tchar.AbstractCharList
Returns the index of the first occurrence of the specified element.
indexOf(double) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns the index of the first occurrence of the specified element.
indexOf(float) - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns the index of the first occurrence of the specified element.
indexOf(int) - Method in class cern.colt.list.tint.AbstractIntList
Returns the index of the first occurrence of the specified element.
indexOf(long) - Method in class cern.colt.list.tlong.AbstractLongList
Returns the index of the first occurrence of the specified element.
indexOf(Object, boolean) - Method in class cern.colt.list.tobject.ObjectArrayList
Returns the index of the first occurrence of the specified element.
indexOf(short) - Method in class cern.colt.list.tshort.AbstractShortList
Returns the index of the first occurrence of the specified element.
indexOf(double) - Method in class flanagan.math.ArrayMaths
 
indexOf(Double) - Method in class flanagan.math.ArrayMaths
 
indexOf(float) - Method in class flanagan.math.ArrayMaths
 
indexOf(Float) - Method in class flanagan.math.ArrayMaths
 
indexOf(long) - Method in class flanagan.math.ArrayMaths
 
indexOf(Long) - Method in class flanagan.math.ArrayMaths
 
indexOf(int) - Method in class flanagan.math.ArrayMaths
 
indexOf(Integer) - Method in class flanagan.math.ArrayMaths
 
indexOf(short) - Method in class flanagan.math.ArrayMaths
 
indexOf(Short) - Method in class flanagan.math.ArrayMaths
 
indexOf(byte) - Method in class flanagan.math.ArrayMaths
 
indexOf(Byte) - Method in class flanagan.math.ArrayMaths
 
indexOf(char) - Method in class flanagan.math.ArrayMaths
 
indexOf(Character) - Method in class flanagan.math.ArrayMaths
 
indexOf(String) - Method in class flanagan.math.ArrayMaths
 
indexOf(Complex) - Method in class flanagan.math.ArrayMaths
 
indexOf(Phasor) - Method in class flanagan.math.ArrayMaths
 
indexOf(BigDecimal) - Method in class flanagan.math.ArrayMaths
 
indexOf(BigInteger) - Method in class flanagan.math.ArrayMaths
 
indexOf(double[], double) - Static method in class flanagan.math.Fmath
 
indexOf(float[], float) - Static method in class flanagan.math.Fmath
 
indexOf(long[], long) - Static method in class flanagan.math.Fmath
 
indexOf(int[], int) - Static method in class flanagan.math.Fmath
 
indexOf(byte[], byte) - Static method in class flanagan.math.Fmath
 
indexOf(short[], short) - Static method in class flanagan.math.Fmath
 
indexOf(char[], char) - Static method in class flanagan.math.Fmath
 
indexOf(String[], String) - Static method in class flanagan.math.Fmath
 
indexOf(Object[], Object) - Static method in class flanagan.math.Fmath
 
indexOf(Object) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
indexOfFromTo(int, int, boolean) - Method in class cern.colt.bitvector.BitVector
Returns the index of the first occurrence of the specified state.
indexOfFromTo(boolean, int, int) - Method in class cern.colt.list.AbstractBooleanList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(byte, int, int) - Method in class cern.colt.list.AbstractByteList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(char, int, int) - Method in class cern.colt.list.AbstractCharList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(double, int, int) - Method in class cern.colt.list.AbstractDoubleList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(float, int, int) - Method in class cern.colt.list.AbstractFloatList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(int, int, int) - Method in class cern.colt.list.AbstractIntList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(long, int, int) - Method in class cern.colt.list.AbstractLongList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(short, int, int) - Method in class cern.colt.list.AbstractShortList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(boolean, int, int) - Method in class cern.colt.list.BooleanArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(byte, int, int) - Method in class cern.colt.list.ByteArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(char, int, int) - Method in class cern.colt.list.CharArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(double, int, int) - Method in class cern.colt.list.DoubleArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(float, int, int) - Method in class cern.colt.list.FloatArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(int, int, int) - Method in class cern.colt.list.IntArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(long, int, int) - Method in class cern.colt.list.LongArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(Object, int, int, boolean) - Method in class cern.colt.list.ObjectArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(short, int, int) - Method in class cern.colt.list.ShortArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(boolean, int, int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(boolean, int, int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(byte, int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(byte, int, int) - Method in class cern.colt.list.tbyte.ByteArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(char, int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(char, int, int) - Method in class cern.colt.list.tchar.CharArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(double, int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(double, int, int) - Method in class cern.colt.list.tdouble.DoubleArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(float, int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(float, int, int) - Method in class cern.colt.list.tfloat.FloatArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(int, int, int) - Method in class cern.colt.list.tint.AbstractIntList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(int, int, int) - Method in class cern.colt.list.tint.IntArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(long, int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(long, int, int) - Method in class cern.colt.list.tlong.LongArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(Object, int, int, boolean) - Method in class cern.colt.list.tobject.ObjectArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(short, int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(short, int, int) - Method in class cern.colt.list.tshort.ShortArrayList
Returns the index of the first occurrence of the specified element.
indexOfFromTo(int, int, boolean) - Method in class cern.colt.matrix.tbit.BitVector
Returns the index of the first occurrence of the specified state.
indexOfFunction(IFunction) - Method in class hep.aida.ref.function.SumOfFunctions
 
indexOfParameter(String) - Method in class hep.aida.ref.fitter.InternalFitFunction
 
indexOfParameter(String) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
indexOfParameter(String) - Method in class hep.aida.ref.function.AbstractIFunction
 
indexOfParameter(String) - Method in class hep.aida.ref.function.BaseModelFunction
 
indexOfParameter(String) - Method in class hep.aida.ref.function.FunctionCore
 
indexOfParameter(String) - Method in class hep.aida.ref.function.SumOfFunctions
 
IndexPlot - Static variable in class jhplot.HChart
 
indicator(byte) - Static method in class org.apache.commons.math.util.MathUtils
For a byte value x, this method returns (byte)(+1) if x >= 0 and (byte)(-1) if x < 0.
indicator(double) - Static method in class org.apache.commons.math.util.MathUtils
For a double precision value x, this method returns +1.0 if x >= 0 and -1.0 if x < 0.
indicator(float) - Static method in class org.apache.commons.math.util.MathUtils
For a float value x, this method returns +1.0F if x >= 0 and -1.0F if x < 0.
indicator(int) - Static method in class org.apache.commons.math.util.MathUtils
For an int value x, this method returns +1 if x >= 0 and -1 if x < 0.
indicator(long) - Static method in class org.apache.commons.math.util.MathUtils
For a long value x, this method returns +1L if x >= 0 and -1L if x < 0.
indicator(short) - Static method in class org.apache.commons.math.util.MathUtils
For a short value x, this method returns (short)(+1) if x >= 0 and (short)(-1) if x < 0.
indicesOf(double) - Method in class flanagan.math.ArrayMaths
 
indicesOf(Double) - Method in class flanagan.math.ArrayMaths
 
indicesOf(float) - Method in class flanagan.math.ArrayMaths
 
indicesOf(Float) - Method in class flanagan.math.ArrayMaths
 
indicesOf(long) - Method in class flanagan.math.ArrayMaths
 
indicesOf(Long) - Method in class flanagan.math.ArrayMaths
 
indicesOf(int) - Method in class flanagan.math.ArrayMaths
 
indicesOf(Integer) - Method in class flanagan.math.ArrayMaths
 
indicesOf(short) - Method in class flanagan.math.ArrayMaths
 
indicesOf(Short) - Method in class flanagan.math.ArrayMaths
 
indicesOf(byte) - Method in class flanagan.math.ArrayMaths
 
indicesOf(Byte) - Method in class flanagan.math.ArrayMaths
 
indicesOf(char) - Method in class flanagan.math.ArrayMaths
 
indicesOf(Character) - Method in class flanagan.math.ArrayMaths
 
indicesOf(String) - Method in class flanagan.math.ArrayMaths
 
indicesOf(Complex) - Method in class flanagan.math.ArrayMaths
 
indicesOf(Phasor) - Method in class flanagan.math.ArrayMaths
 
indicesOf(BigDecimal) - Method in class flanagan.math.ArrayMaths
 
indicesOf(BigInteger) - Method in class flanagan.math.ArrayMaths
 
indicesOf(double[], double) - Static method in class flanagan.math.Fmath
 
indicesOf(float[], float) - Static method in class flanagan.math.Fmath
 
indicesOf(long[], long) - Static method in class flanagan.math.Fmath
 
indicesOf(int[], int) - Static method in class flanagan.math.Fmath
 
indicesOf(short[], short) - Static method in class flanagan.math.Fmath
 
indicesOf(byte[], byte) - Static method in class flanagan.math.Fmath
 
indicesOf(char[], char) - Static method in class flanagan.math.Fmath
 
indicesOf(String[], String) - Static method in class flanagan.math.Fmath
 
indicesOf(Object[], Object) - Static method in class flanagan.math.Fmath
 
indicesOfReplacedScores() - Method in class flanagan.analysis.Scores
 
inducedPermutation(List<S>, List<S>) - Static method in class org.apache.commons.math.genetics.RandomKey
Generates a representation of a permutation corresponding to a permutation which yields permutedData when applied to originalData.
INF - Static variable in class org.apache.commons.math.complex.Complex
A complex number representing "+INF + INFi"
INFINITE - Static variable in class org.apache.commons.math.dfp.Dfp
Indicator value for Infinity.
INFINITE_WINDOW - Static variable in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Represents an infinite window size.
infinityCheck(double, int) - Method in class flanagan.analysis.Regression
 
infinityNorm() - Method in class flanagan.math.Matrix
 
init(String, String, int, String) - Method in class hep.aida.ref.tree.Tree
Non-AIDA methods are down here.
init(String, boolean, boolean, String, String, boolean) - Method in class hep.aida.ref.tree.Tree
Associate the tree with a store
init(int) - Method in class jhplot.bsom.Bsom
 
init() - Method in class jhplot.bsom.BsomDemo
 
init() - Static method in class jhplot.JHPlot
Initialization.
init() - Method in class jhplot.v3d.Animation
 
init() - Method in class jhpro.stat.limit.LimitCalculatorGui
 
init(double[]) - Method in class umontreal.iro.lecuyer.hups.HaltonSequence
Initializes the Halton sequence starting at point x0.
init(byte[], int) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Initializes array with the first n positive integers in natural order as array[i - 1] = i, for i = 1,..., n.
init(short[], int) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to init(byte[], int).
init(int[], int) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to init(byte[], int).
init(long[], int) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to init(byte[], int).
init(float[], int) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to init(byte[], int).
init(double[], int) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to init(byte[], int).
init() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Initializes the statistical collector and puts the current value of the corresponding variable to 0.
init(double) - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Same as init followed by update(x).
init(double) - Method in class umontreal.iro.lecuyer.simevents.Continuous
Initializes or reinitializes the continuous-time variable to val.
init() - Static method in class umontreal.iro.lecuyer.simevents.Sim
Reinitializes the simulation executive by clearing up the event list, and resetting the simulation clock to zero.
init(EventList) - Static method in class umontreal.iro.lecuyer.simevents.Sim
Same as init, but also chooses evlist as the event list to be used.
init() - Method in class umontreal.iro.lecuyer.simevents.Simulator
Reinitializes the simulation executive by clearing up the event list, and resetting the simulation clock to zero.
init(EventList) - Method in class umontreal.iro.lecuyer.simevents.Simulator
Same as init, but also chooses evlist as the event list to be used.
init() - Method in class umontreal.iro.lecuyer.simprocs.Bin
Reinitializes this bin by clearing up its pile of tokens and its waiting list.
init(boolean) - Method in class umontreal.iro.lecuyer.simprocs.Condition
Reinitializes this Condition by clearing up its waiting list and resetting its state to val.
init() - Method in class umontreal.iro.lecuyer.simprocs.DSOLProcessSimulator
Initializes the process-driven simulation.
init(EventList) - Method in class umontreal.iro.lecuyer.simprocs.DSOLProcessSimulator
Initializes the simulation and sets the given event list evlist to be used by the simulation executive.
init() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Reinitializes this resource by clearing up its waiting list and service list.
init() - Static method in class umontreal.iro.lecuyer.simprocs.SimProcess
This method calls ProcessSimulator.initDefault(), which initializes the default simulator to use processes.
init() - Method in class umontreal.iro.lecuyer.simprocs.ThreadProcessSimulator
Initializes the thread process-driven simulation using SplayTree algorithm as EventList.
init(EventList) - Method in class umontreal.iro.lecuyer.simprocs.ThreadProcessSimulator
Initializes the thread process-driven simulation using evlist variable as EventList.
init() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Initializes this list of statistical probes by calling init on each element.
init() - Method in class umontreal.iro.lecuyer.stat.list.ListOfTalliesWithCovariance
 
init() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Initializes the statistical collector.
init() - Method in class umontreal.iro.lecuyer.stat.Tally
 
init() - Method in class umontreal.iro.lecuyer.stat.TallyStore
 
init() - Method in class umontreal.iro.lecuyer.util.AbstractChrono
Initializes this AbstractChrono to zero.
INIT_SIZE - Static variable in class jhplot.jadraw.JaObject
An integer that gives the initial size of an object.
initBinner(Binner1D) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
initCache() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Resets this generator to recover values from the cache.
initCache() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Resets this random stream to recover values from the cache.
initCloud(int, String) - Method in class hep.aida.ref.histogram.Cloud
 
initDefault() - Static method in class umontreal.iro.lecuyer.simprocs.ProcessSimulator
Initializes the default simulator to use processes.
initHistogram1D(IAxis, String) - Method in class hep.aida.ref.histogram.Histogram1D
 
initHistogram2D(IAxis, IAxis, String) - Method in class hep.aida.ref.histogram.Histogram2D
 
initHistogram3D(IAxis, IAxis, IAxis, String) - Method in class hep.aida.ref.histogram.Histogram3D
 
INITIAL - Static variable in class umontreal.iro.lecuyer.simprocs.SimProcess
The process has been created but not yet scheduled.
initialize(ITuple) - Method in class hep.aida.ref.fitter.fitdata.RangeSetFilter
 
initialize(ITuple) - Method in class hep.aida.ref.tuple.Evaluator
 
initialize(ITuple) - Method in class hep.aida.ref.tuple.Filter
 
initialize() - Method in interface jhplot.math.num.IterativeMethod.IterativeState
Initialize the state to begin an iterative evaluation.
initializeHighOrderDerivatives(double[], double[][]) - Method in interface org.apache.commons.math.ode.MultistepIntegrator.NordsieckTransformer
Initialize the high order scaled derivatives at step start.
initializeHighOrderDerivatives(double[], double[][]) - Method in class org.apache.commons.math.ode.nonstiff.AdamsNordsieckTransformer
Initialize the high order scaled derivatives at step start.
initializeStep(FirstOrderDifferentialEquations, boolean, int, double[], double, double[], double[], double[], double[]) - Method in class org.apache.commons.math.ode.nonstiff.AdaptiveStepsizeIntegrator
Initialize the integration step.
initPar(double, double, int) - Method in class jhplot.bsom.Bsom
initialize learning
initProfile1D(IAxis) - Method in class hep.aida.ref.histogram.Profile1D
 
initProfile1D(IAxis, String) - Method in class hep.aida.ref.histogram.Profile1D
 
initProfile2D(IAxis, IAxis) - Method in class hep.aida.ref.histogram.Profile2D
 
initProfile2D(IAxis, IAxis, String) - Method in class hep.aida.ref.histogram.Profile2D
 
initStat() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
Reinitializes the two statistical probes created by setStatCollecting (true) and makes an update for the probe on the list size.
initStat() - Method in class umontreal.iro.lecuyer.simprocs.Bin
Reinitializes all the statistical collectors for this bin.
initStat() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Reinitializes all the statistical collectors for this resource.
insert(String, Object) - Method in class jhplot.io.HDataBase
Insert an object with a key
insert(double[], int, double...) - Static method in class jhplot.math.DoubleArray
Insert any number of values, or a single array, between 2 elements of an array.
insert(int[], int, int...) - Static method in class jhplot.math.IntegerArray
 
insertColumn(int[][], int[], int) - Static method in class jhplot.math.IntegerArray
 
insertColumns(double[][], int, double[]...) - Static method in class jhplot.math.DoubleArray
Insert any number of arrays between 2 columns of a matrix.
insertColumns(int[][], int[][], int) - Static method in class jhplot.math.IntegerArray
 
insertRecord(RecordWriter) - Method in class jhplot.io.BaseRecordsFile
Adds the given record to the database.
insertRow(int[][], int[], int) - Static method in class jhplot.math.IntegerArray
 
insertRows(double[][], int, double[]...) - Static method in class jhplot.math.DoubleArray
Insert any number of arrays between 2 rows of a matrix.
insertRows(int[][], int[][], int) - Static method in class jhplot.math.IntegerArray
 
int2double(int[][]) - Static method in class jhplot.math.IntegerArray
 
int2double(int[]) - Static method in class jhplot.math.IntegerArray
 
IntArrayList - Class in cern.colt.list
Resizable list holding int elements; implemented with arrays.
IntArrayList() - Constructor for class cern.colt.list.IntArrayList
Constructs an empty list.
IntArrayList(int[]) - Constructor for class cern.colt.list.IntArrayList
Constructs a list containing the specified elements.
IntArrayList(int) - Constructor for class cern.colt.list.IntArrayList
Constructs an empty list with the specified initial capacity.
IntArrayList - Class in cern.colt.list.tint
Resizable list holding int elements; implemented with arrays.
IntArrayList() - Constructor for class cern.colt.list.tint.IntArrayList
Constructs an empty list.
IntArrayList(int[]) - Constructor for class cern.colt.list.tint.IntArrayList
Constructs a list containing the specified elements.
IntArrayList(int) - Constructor for class cern.colt.list.tint.IntArrayList
Constructs an empty list with the specified initial capacity.
IntBuffer - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target IntBufferConsumer to which data is automatically flushed upon buffer overflow.
IntBuffer(IntBufferConsumer, int) - Constructor for class cern.colt.buffer.IntBuffer
Constructs and returns a new buffer with the given target.
IntBuffer - Class in cern.colt.buffer.tint
Fixed sized (non resizable) streaming buffer connected to a target IntBufferConsumer to which data is automatically flushed upon buffer overflow.
IntBuffer(IntBufferConsumer, int) - Constructor for class cern.colt.buffer.tint.IntBuffer
Constructs and returns a new buffer with the given target.
IntBuffer2D - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target IntBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
IntBuffer2D(IntBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.IntBuffer2D
Constructs and returns a new buffer with the given target.
IntBuffer2D - Class in cern.colt.buffer.tint
Fixed sized (non resizable) streaming buffer connected to a target IntBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
IntBuffer2D(IntBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.tint.IntBuffer2D
Constructs and returns a new buffer with the given target.
IntBuffer2DConsumer - Interface in cern.colt.buffer
Target of a streaming IntBuffer2D into which data is flushed upon buffer overflow.
IntBuffer2DConsumer - Interface in cern.colt.buffer.tint
Target of a streaming IntBuffer2D into which data is flushed upon buffer overflow.
IntBuffer3D - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target IntBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
IntBuffer3D(IntBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.IntBuffer3D
Constructs and returns a new buffer with the given target.
IntBuffer3D - Class in cern.colt.buffer.tint
Fixed sized (non resizable) streaming buffer connected to a target IntBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
IntBuffer3D(IntBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.tint.IntBuffer3D
Constructs and returns a new buffer with the given target.
IntBuffer3DConsumer - Interface in cern.colt.buffer
Target of a streaming IntBuffer3D into which data is flushed upon buffer overflow.
IntBuffer3DConsumer - Interface in cern.colt.buffer.tint
Target of a streaming IntBuffer3D into which data is flushed upon buffer overflow.
IntBufferConsumer - Interface in cern.colt.buffer
Target of a streaming IntBuffer into which data is flushed upon buffer overflow.
IntBufferConsumer - Interface in cern.colt.buffer.tint
Target of a streaming IntBuffer into which data is flushed upon buffer overflow.
IntComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
IntComparator - Interface in cern.colt.function.tint
A comparison function which imposes a total ordering on some collection of elements.
IntDoubleFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes two arguments.
IntDoubleFunction - Interface in cern.colt.function.tdouble
Interface that represents a function object: a function that takes two arguments.
IntDoubleProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
IntDoubleProcedure - Interface in cern.colt.function.tdouble
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
integerArray(int, int) - Method in class flanagan.math.PsRandom
 
integerArray(int, int, int) - Method in class flanagan.math.PsRandom
 
IntegerArray - Class in jhplot.math
BSD License
IntegerArray() - Constructor for class jhplot.math.IntegerArray
 
IntegerDistribution - Interface in org.apache.commons.math.distribution
Interface for discrete distributions of integer-valued random variables.
integerRadicalInverse(int, int) - Static method in class umontreal.iro.lecuyer.hups.RadicalInverse
Computes the integer radical inverse of i in base b, equal to bkψb(i) if i has k b-ary digits.
integMethod() - Method in class umontreal.iro.lecuyer.simevents.ContinuousState
Return an integer that represent the integration method in use.
integral(String, int, double, double) - Method in class jhplot.F1D
Numerical integration.
integral(int, double, double) - Method in class jhplot.F1D
Numerical integration using trapezium rule.
integral(int, double, double, double, double) - Method in class jhplot.F2D
Numerical integration using trapezium rule.
integral() - Method in class jhplot.H1D
Sum of all heights
integral(int, int, boolean) - Method in class jhplot.H1D
Integrate a histogram between two bin indices (between 1 and max number) The integral is computed as the sum of bin contents in the range if the last parameter is false.
integral(int, int) - Method in class jhplot.H1D
Integrate a histogram between two bin indices (between 1 and max number) By default the integral is computed as the sum of bin contents in the range.
integral(int, int, int, int) - Method in class jhplot.H2D
Integrate histogram between two indices.
integral(int, int, int, int, boolean) - Method in class jhplot.H2D
Integrate histogram between two indices.
integral(int, int) - Method in class jhplot.P1D
Integrate P1D between two indices (between 1 and max index)
integral() - Method in class jhplot.P1D
Integrate P1D (sum up all Y values)
integral(double, double) - Method in class umontreal.iro.lecuyer.functionfit.BSpline
 
integral(double, double) - Method in class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Evaluates and returns the value of the integral of the spline from a to b.
integral(double, double) - Method in class umontreal.iro.lecuyer.functions.AverageMathFunction
 
integral(double, double) - Method in class umontreal.iro.lecuyer.functions.IdentityMathFunction
 
integral(MathFunction, double, double) - Static method in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Returns the integral of the function func over [a, b].
integral(double, double) - Method in interface umontreal.iro.lecuyer.functions.MathFunctionWithIntegral
Computes (or estimates) the integral of the function over the interval [a, b].
integral(double, double) - Method in class umontreal.iro.lecuyer.functions.Polynomial
 
integral(double, double) - Method in class umontreal.iro.lecuyer.functions.ShiftedMathFunction
 
IntegralFunction - Interface in flanagan.integration
 
integralMC(IModelFunction) - Static method in class hep.aida.ref.function.FunctionIntegrator
 
integralPolynomial(double) - Method in class umontreal.iro.lecuyer.functions.Polynomial
Returns a polynomial representing the integral of this polynomial.
integralRange(double, double, double, double, boolean) - Method in class jhplot.H2D
Integrate histogram in the range.
integralRegion(double, double, boolean) - Method in class jhplot.H1D
Integrate histogram in a region between Xmin and Xmax.
integralRegion(double, double) - Method in class jhplot.H1D
Integrate histogram in a region between Xmin and Xmax.
integralSimpson(IModelFunction) - Static method in class hep.aida.ref.function.FunctionIntegrator
 
integralTrapezoid(IModelFunction) - Static method in class hep.aida.ref.function.FunctionIntegrator
 
integralVegasMC(IModelFunction) - Static method in class hep.aida.ref.function.FunctionIntegrator
 
integrate(double, double) - Method in class jhplot.math.num.integration.AdaptiveIntegrator
Evaluate the definite integral from a to b.
integrate(double, double) - Method in class jhplot.math.num.integration.RombergIntegrator
Evaluate the definite integral from a to b.
integrate(double, double) - Method in class jhplot.math.num.integration.SimpsonsIntegrator
Evaluate the definite integral from a to b.
integrate(double, double) - Method in class jhplot.math.num.integration.TrapezoidalIntegrator
Evaluate the definite integral from a to b.
integrate(double, double) - Method in class org.apache.commons.math.analysis.integration.LegendreGaussIntegrator
Deprecated. 
integrate(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.integration.LegendreGaussIntegrator
Integrate the function in the given interval.
integrate(double, double) - Method in class org.apache.commons.math.analysis.integration.RombergIntegrator
Deprecated. 
integrate(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.integration.RombergIntegrator
Integrate the function in the given interval.
integrate(double, double) - Method in class org.apache.commons.math.analysis.integration.SimpsonIntegrator
Deprecated. 
integrate(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.integration.SimpsonIntegrator
Integrate the function in the given interval.
integrate(double, double) - Method in class org.apache.commons.math.analysis.integration.TrapezoidIntegrator
Deprecated. 
integrate(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.integration.TrapezoidIntegrator
Integrate the function in the given interval.
integrate(double, double) - Method in interface org.apache.commons.math.analysis.integration.UnivariateRealIntegrator
Deprecated. replaced by UnivariateRealIntegrator.integrate(UnivariateRealFunction, double, double) since 2.0
integrate(UnivariateRealFunction, double, double) - Method in interface org.apache.commons.math.analysis.integration.UnivariateRealIntegrator
Integrate the function in the given interval.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in interface org.apache.commons.math.ode.FirstOrderIntegrator
Integrate the differential equations up to the given time.
integrate(double, double[], double[][], double, double[], double[][], double[][]) - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Integrate the differential equations and the variational equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.nonstiff.AdamsBashforthIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.nonstiff.AdamsIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.nonstiff.AdamsMoultonIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.nonstiff.AdaptiveStepsizeIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.nonstiff.GraggBulirschStoerIntegrator
Integrate the differential equations up to the given time.
integrate(FirstOrderDifferentialEquations, double, double[], double, double[]) - Method in class org.apache.commons.math.ode.nonstiff.RungeKuttaIntegrator
Integrate the differential equations up to the given time.
integrate(SecondOrderDifferentialEquations, double, double[], double[], double, double[], double[]) - Method in interface org.apache.commons.math.ode.SecondOrderIntegrator
Integrate the differential equations up to the given time
Integration - Class in flanagan.integration
 
Integration() - Constructor for class flanagan.integration.Integration
 
Integration(IntegralFunction) - Constructor for class flanagan.integration.Integration
 
Integration(IntegralFunction, double, double) - Constructor for class flanagan.integration.Integration
 
IntegratorException - Exception in org.apache.commons.math.ode
This exception is made available to users to report the error conditions that are triggered during integration
IntegratorException(String, Object...) - Constructor for exception org.apache.commons.math.ode.IntegratorException
Deprecated. as of 2.2 replaced by IntegratorException.IntegratorException(Localizable, Object...)
IntegratorException(Localizable, Object...) - Constructor for exception org.apache.commons.math.ode.IntegratorException
Simple constructor.
IntegratorException(Throwable) - Constructor for exception org.apache.commons.math.ode.IntegratorException
Create an exception with a given root cause.
InternalFitFunction - Class in hep.aida.ref.fitter
 
InternalFitFunction(IDevFitDataIterator, IModelFunction, IFitMethod) - Constructor for class hep.aida.ref.fitter.InternalFitFunction
 
interpol(int, double[], double[], double[]) - Static method in class umontreal.iro.lecuyer.util.Misc
Computes the Newton interpolating polynomial.
interpolate(double, double) - Method in class flanagan.interpolation.BiCubicSpline
 
interpolate(double, double) - Method in class flanagan.interpolation.BiCubicSplineFast
 
interpolate(double, double) - Method in class flanagan.interpolation.BiCubicSplineFirstDerivative
 
interpolate(double, double) - Method in class flanagan.interpolation.BiCubicSplinePartialDerivative
 
interpolate(double, double) - Method in class flanagan.interpolation.BiCubicSplineShort
 
interpolate(double) - Method in class flanagan.interpolation.CubicSpline
 
interpolate(double, double[], double[], double[]) - Static method in class flanagan.interpolation.CubicSpline
 
interpolate(double) - Method in class flanagan.interpolation.CubicSplineFast
 
interpolate(double) - Method in class flanagan.interpolation.CubicSplineShort
 
interpolate(double[]) - Method in class flanagan.interpolation.PolyCubicSpline
 
interpolate(double[]) - Method in class flanagan.interpolation.PolyCubicSplineFast
 
interpolate(double, double, double, double) - Method in class flanagan.interpolation.QuadriCubicSpline
 
interpolate(double, double, double) - Method in class flanagan.interpolation.TriCubicSpline
 
interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[], double[][]) - Method in interface org.apache.commons.math.analysis.interpolation.BivariateRealGridInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math.analysis.interpolation.DividedDifferenceInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math.analysis.interpolation.LinearInterpolator
Computes a linear interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math.analysis.interpolation.LoessInterpolator
Compute an interpolating function by performing a loess fit on the data at the original abscissae and then building a cubic spline with a SplineInterpolator on the resulting fit.
interpolate(double[][], double[]) - Method in class org.apache.commons.math.analysis.interpolation.MicrosphereInterpolator
Computes an interpolating function for the data set.
interpolate(double[][], double[]) - Method in interface org.apache.commons.math.analysis.interpolation.MultivariateRealInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math.analysis.interpolation.NevilleInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math.analysis.interpolation.SmoothingBicubicSplineInterpolator
Deprecated. Computes an interpolating function for the data set.
interpolate(double[], double[], double[][]) - Method in class org.apache.commons.math.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[]) - Method in class org.apache.commons.math.analysis.interpolation.SplineInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[], double[], double[][][]) - Method in class org.apache.commons.math.analysis.interpolation.TricubicSplineInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[], double[], double[][][]) - Method in interface org.apache.commons.math.analysis.interpolation.TrivariateRealGridInterpolator
Computes an interpolating function for the data set.
interpolate(double[], double[]) - Method in interface org.apache.commons.math.analysis.interpolation.UnivariateRealInterpolator
Computes an interpolating function for the data set.
interpolate_for_y_and_dydx(double) - Method in class flanagan.interpolation.CubicSpline
 
interpolateCubicSpline(double, int) - Method in class jhplot.stat.Interpolator
Calculate a spline with nodes at (x, y), with weights w and smoothing factor rho.
interpolateLoess(double, int, double, int) - Method in class jhplot.stat.Interpolator
Performs a Local Regression Algorithm (also Loess, Lowess) for interpolation of data points.
interpolateNatuarlCubicSpline() - Method in class jhplot.stat.Interpolator
Natural cubic splines interpolation.
Interpolator - Class in jhplot.stat
Perform interpolation of a data using different algorithm.
Interpolator(double[], double[]) - Constructor for class jhplot.stat.Interpolator
Initialize interpolator
Interpolator(P1D) - Constructor for class jhplot.stat.Interpolator
Initialize interpolator for P1D array.
Interpolator(H1D) - Constructor for class jhplot.stat.Interpolator
Initialize interpolator for a histogram.
Interpolator.Cubic - Class in jhplot.stat
represents a cubic polynomial.
Interpolator.Cubic(double, double, double, double) - Constructor for class jhplot.stat.Interpolator.Cubic
a + b*u + c*u^2 +d*u^3
interQuartileMean() - Method in class flanagan.analysis.Stat
 
interQuartileMean(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
interQuartileMean(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
interQuartileMean(double[]) - Static method in class flanagan.analysis.Stat
 
interQuartileMean(float[]) - Static method in class flanagan.analysis.Stat
 
interQuartileMean_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
interQuartileMean_as_double() - Method in class flanagan.analysis.Stat
 
IntFactory1D - Class in cern.colt.matrix.tint
Factory for convenient construction of 1-d matrices holding int cells.
IntFactory2D - Class in cern.colt.matrix.tint
Factory for convenient construction of 2-d matrices holding int cells.
IntFactory3D - Class in cern.colt.matrix.tint
Factory for convenient construction of 3-d matrices holding int cells.
IntFloatProcedure - Interface in cern.colt.function.tfloat
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
IntFormatter - Class in cern.colt.matrix.tint.algo
Flexible, well human readable matrix print formatting; By default decimal point aligned.
IntFormatter() - Constructor for class cern.colt.matrix.tint.algo.IntFormatter
Constructs and returns a matrix formatter with format "%G".
IntFormatter(String) - Constructor for class cern.colt.matrix.tint.algo.IntFormatter
Constructs and returns a matrix formatter.
IntFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes a single argument and returns a single value.
IntFunction - Interface in cern.colt.function.tint
Interface that represents a function object: a function that takes a single argument and returns a single value.
IntFunctions - Class in cern.jet.math
Integer Function objects to be passed to generic methods.
intFunctions - Static variable in class cern.jet.math.IntFunctions
Little trick to allow for "aliasing", that is, renaming this class.
IntFunctions - Class in cern.jet.math.tint
Int Function objects to be passed to generic methods.
intFunctions - Static variable in class cern.jet.math.tint.IntFunctions
Little trick to allow for "aliasing", that is, renaming this class.
IntIntDComplexFunction - Interface in cern.colt.function.tdcomplex
Interface that represents a function object: a function that takes three arguments.
IntIntDoubleFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes three arguments.
IntIntDoubleFunction - Interface in cern.colt.function.tdouble
Interface that represents a function object: a function that takes three arguments.
IntIntDoubleProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes three arguments and does not return a value.
IntIntDoubleProcedure - Interface in cern.colt.function.tdouble
Interface that represents a procedure object: a procedure that takes three arguments and does not return a value.
IntIntFComplexFunction - Interface in cern.colt.function.tfcomplex
Interface that represents a function object: a function that takes three arguments.
IntIntFloatFunction - Interface in cern.colt.function.tfloat
Interface that represents a function object: a function that takes three arguments.
IntIntFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes two arguments and returns a single value.
IntIntFunction - Interface in cern.colt.function.tint
Interface that represents a function object: a function that takes two arguments and returns a single value.
IntIntIntFunction - Interface in cern.colt.function.tint
Interface that represents a function object: a function that takes three arguments.
IntIntIntProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes three arguments and does not return a value.
IntIntIntProcedure - Interface in cern.colt.function.tint
Interface that represents a procedure object: a procedure that takes three arguments and does not return a value.
IntIntLongFunction - Interface in cern.colt.function.tlong
Interface that represents a function object: a function that takes three arguments.
IntIntObjectFunction - Interface in cern.colt.function.tobject
Interface that represents a function object: a function that takes three arguments.
IntIntProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
IntIntProcedure - Interface in cern.colt.function.tint
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
IntListAdapter - Class in cern.colt.list.adapter
Adapter that permits an AbstractIntList to be viewed and treated as a JDK 1.2 AbstractList.
IntListAdapter(AbstractIntList) - Constructor for class cern.colt.list.adapter.IntListAdapter
Constructs a list backed by the specified content list.
IntListAdapter - Class in cern.colt.list.tint
Adapter that permits an AbstractIntList to be viewed and treated as a JDK 1.2 AbstractList.
IntListAdapter(AbstractIntList) - Constructor for class cern.colt.list.tint.IntListAdapter
Constructs a list backed by the specified content list.
IntLongProcedure - Interface in cern.colt.function.tlong
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
IntMatrix1D - Class in cern.colt.matrix.tint
Abstract base class for 1-d matrices (aka vectors) holding int elements.
IntMatrix1DComparator - Interface in cern.colt.matrix.tint.algo
A comparison function which imposes a total ordering on some collection of elements.
IntMatrix1DProcedure - Interface in cern.colt.matrix.tint
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
IntMatrix2D - Class in cern.colt.matrix.tint
Abstract base class for 2-d matrices holding int elements.
IntMatrix2DComparator - Interface in cern.colt.matrix.tint.algo
A comparison function which imposes a total ordering on some collection of elements.
IntMatrix2DProcedure - Interface in cern.colt.matrix.tint
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
IntMatrix3D - Class in cern.colt.matrix.tint
Abstract base class for 3-d matrices holding int elements.
IntMatrix3DProcedure - Interface in cern.colt.matrix.tint
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
IntMult - Class in cern.jet.math.tint
Only for performance tuning of compute intensive linear algebraic computations.
IntObjectProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
IntObjectProcedure - Interface in cern.colt.function.tobject
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
IntPlusMultFirst - Class in cern.jet.math.tint
Only for performance tuning of compute intensive linear algebraic computations.
IntPlusMultSecond - Class in cern.jet.math.tint
Only for performance tuning of compute intensive linear algebraic computations.
IntProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
IntProcedure - Interface in cern.colt.function.tint
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
IntProperty - Class in cern.colt.matrix.tint.algo
Tests matrices for linear algebraic properties (equality, tridiagonality, symmetry, singularity, etc).
IntProperty() - Constructor for class cern.colt.matrix.tint.algo.IntProperty
Constructs an instance with a tolerance of Math.abs(newTolerance).
Introspection - Class in umontreal.iro.lecuyer.util
Provides utility methods for introspection using Java Reflection API.
IntSorting - Class in cern.colt.matrix.tint.algo
Matrix quicksorts and mergesorts.
intTOdouble(int[]) - Static method in class flanagan.math.Fmath
 
intTOfloat(int[]) - Static method in class flanagan.math.Fmath
 
intTOlong(int[]) - Static method in class flanagan.math.Fmath
 
intValue() - Method in class org.apache.commons.math.dfp.Dfp
Convert this to an integer.
intValue() - Method in class org.apache.commons.math.fraction.BigFraction
Gets the fraction as an int.
intValue() - Method in class org.apache.commons.math.fraction.Fraction
Gets the fraction as an int.
inv - Static variable in class cern.jet.math.Functions
Function that returns 1.0 / a.
inv(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
inv - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
inv - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns 1.0 / a.
inv(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
inv - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
inv - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns 1.0 / a.
inv_center_reduce(double[]) - Method in class jhplot.stat.PCA
 
inv_center_reduce(double[][]) - Method in class jhplot.stat.PCA
 
InvalidMatrixException - Exception in org.apache.commons.math.linear
Thrown when a system attempts an operation on a matrix, and that matrix does not satisfy the preconditions for the aforementioned operation.
InvalidMatrixException(String, Object...) - Constructor for exception org.apache.commons.math.linear.InvalidMatrixException
Deprecated. since 2.2 replaced by InvalidMatrixException.InvalidMatrixException(Localizable, Object...)
InvalidMatrixException(Localizable, Object...) - Constructor for exception org.apache.commons.math.linear.InvalidMatrixException
Construct an exception with the given message.
InvalidMatrixException(Throwable) - Constructor for exception org.apache.commons.math.linear.InvalidMatrixException
Construct an exception with the given message.
InvalidRepresentationException - Exception in org.apache.commons.math.genetics
Exception indicating that the representation of a chromosome is not valid.
InvalidRepresentationException() - Constructor for exception org.apache.commons.math.genetics.InvalidRepresentationException
Constructor
InvalidRepresentationException(String) - Constructor for exception org.apache.commons.math.genetics.InvalidRepresentationException
Construct an InvalidRepresentationException
InvalidRepresentationException(Throwable) - Constructor for exception org.apache.commons.math.genetics.InvalidRepresentationException
Construct an InvalidRepresentationException
InvalidRepresentationException(String, Throwable) - Constructor for exception org.apache.commons.math.genetics.InvalidRepresentationException
Construct an InvalidRepresentationException
invariantMass() - Method in class hephysics.vec.HepLorentzVector
Same as m().
invariantMass2() - Method in class hephysics.vec.HepLorentzVector
Same as m2().
inverse(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the inverse or pseudo-inverse of matrix A.
inverse(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the inverse or pseudo-inverse of matrix A.
inverse(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the inverse or pseudo-inverse of matrix A.
inverse() - Method in class flanagan.analysis.ErrorProp
 
inverse(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
inverse() - Method in class flanagan.math.FourierTransform
 
inverse() - Method in class flanagan.math.Matrix
 
inverse(Matrix) - Static method in class flanagan.math.Matrix
 
inverse(Matrix, MutableMatrix) - Static method in class hephysics.matrix.MatrixOp
Invert matrix mIn and write it to matrix mOut.
inverse(Hep3Matrix) - Static method in class hephysics.vec.VecOp
 
inverse(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
inverse(int[]) - Static method in class jhplot.math.SortUtils
Compute inverse permutation
inverse() - Method in class jhplot.math.ValueErr
Returns the inverse (1/a) of a ValueErr number
inverse(ValueErr) - Static method in class jhplot.math.ValueErr
Returns the reciprocal (1/a) of a ValueErr number (a)
inverse() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Deprecated. 
inverse() - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the inverse of this matrix.
inverse() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the inverse matrix if this matrix is invertible.
inverse() - Method in interface org.apache.commons.math.linear.RealMatrix
Deprecated. as of release 2.0, replaced by new LUDecompositionImpl(m).getSolver().getInverse()
inverseBisection(double) - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Computes and returns the inverse distribution function x = F-1(u), using bisection.
inverseBrent(double, double, double, double) - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Computes the inverse distribution function x = F-1(u), using the Brent-Dekker method.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Beta
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Binomial
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Cauchy
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.ChiSquared
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.ContinuousDistribution
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.DiscreteDistribution
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Exponential
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.FDistribution
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Gamma
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Geometric
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Hypergeometric
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Laplace
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Logistic
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.LogNormal
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.NegativeBinomial
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Normal
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Poisson
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Rayleigh
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.TDistribution
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Uniform
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class jhplot.math.num.pdf.Weibull
The inverse CDF for this distribution.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.AbstractContinuousDistribution
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns the largest x, such that P(X ≤ x) ≤ p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
For this distribution, X, this method returns the largest x, such that P(X ≤ x) ≤ p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in interface org.apache.commons.math.distribution.ContinuousDistribution
For this distribution, X, this method returns x such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in interface org.apache.commons.math.distribution.IntegerDistribution
For this distribution, X, this method returns the largest x such that P(X ≤ x) <= p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
For this distribution, X, this method returns the largest x, such that P(X ≤ x) ≤ p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.TDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
inverseCumulativeProbability(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
For this distribution, X, this method returns the critical point x, such that P(X < x) = p.
InverseDistFromDensity - Class in umontreal.iro.lecuyer.probdist
Implements a method for computing the inverse of an arbitrary continuous distribution function when only the probability density is known.
InverseDistFromDensity(ContinuousDistribution, double, double, int) - Constructor for class umontreal.iro.lecuyer.probdist.InverseDistFromDensity
Given a continuous distribution dist with a well-defined density method, this class will compute tables for the numerical inverse of the distribution.
InverseDistFromDensity(MathFunction, double, double, int, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.InverseDistFromDensity
Given a continuous probability density dens, this class will compute tables for the numerical inverse of the distribution.
inverseErf(double) - Static method in class jhplot.math.num.special.Erf
Returns the inverse error function erf-1(y).
inverseExponentialCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
Computes the inverse x = Fn-1(u) of the Anderson-Darling distribution with parameter n.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDistQuick
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDistQuick
Computes the inverse x = Fn-1(u) of the distribution with parameter n.
inverseF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Returns the inverse of the Bernoulli distribution function with parameter p at u.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.BetaDist
 
inverseF(double, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Same as inverseF (alpha, beta, 0, 1, d, u).
inverseF(double, double, double, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaDist
Returns the inverse beta distribution function using the algorithm implemented in the Cephes math library.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
 
inverseF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
Returns the inverse distribution function evaluated at u, for the symmetrical beta distribution over the interval [0, 1], with shape parameters 0 < α = β = alpha.
inverseF(int, double, double) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Computes the inverse of the binomial distribution, x = F-1(u), using a linear search starting at the mode if n is small.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.CauchyDist
Computes the inverse of the distribution.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.ChiDist
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiDist
Returns the inverse distribution function computed using the gamma inversion.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Computes an approximation of F-1(u), where F is the chi-square distribution with n degrees of freedom.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDistQuick
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareDistQuick
Computes a quick-and-dirty approximation of F-1(u), where F is the chi-square distribution with n degrees of freedom.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Computes the inverse of the noncentral chi-square distribution with ν = nu degrees of freedom and parameter λ = lambda.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Returns the inverse distribution function x = F-1(u).
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Computes x = Fn-1(u), where Fn is the Cramér-von Mises distribution with parameter n.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
 
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
Returns the inverse distribution function F-1(u), where 0 <= u <= 1.
inverseF(double) - Method in interface umontreal.iro.lecuyer.probdist.Distribution
Returns the inverse distribution function F-1(u), defined in.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
 
inverseF(int, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.ErlangDist
Returns the inverse distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
 
inverseF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Computes the inverse distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated.  
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Computes the inverse distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
 
inverseF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Computes the inverse of the fatigue life distribution with parameters μ, β and γ.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
 
inverseF(int, int, int, double) - Static method in class umontreal.iro.lecuyer.probdist.FisherFDist
Computes the inverse of the Fisher F distribution with parameters n and m, evaluated at x, with roughly d decimal digits of precision.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Computes the inverse of the distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
 
inverseF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.FrechetDist
Computes and returns the inverse distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.GammaDist
 
inverseF(double, double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Computes the inverse distribution function.
inverseF(double, int, double) - Static method in class umontreal.iro.lecuyer.probdist.GammaDist
Same as inverseF (alpha, 1, d, u).
inverseF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.GeometricDist
Computes the inverse of the geometric distribution.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.GumbelDist
Computes and returns the inverse distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Computes the inverse of the distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Computes the inverse of the hyperbolic secant distribution with parameters μ and σ.
inverseF(int, int, int, double) - Static method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Computes F-1(u) for the hypergeometric distribution without using precomputed tables.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.InverseDistFromDensity
Computes the inverse distribution function at u.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Computes the inverse distribution function of the inverse gamma distribution with shape parameter α and scale parameter β.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Computes the inverse of the inverse gaussian distribution with parameters μ and λ.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
 
inverseF(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Computes the inverse of the distribution.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
 
inverseF(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Computes the inverse distribution function F-1(u).
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
Computes the inverse x = F-1(u) of the distribution F(x) with parameter n.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDistQuick
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDistQuick
Computes the inverse x = F-1(u) of the distribution F(x) with parameter n.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
Computes the inverse x = F-1(u) of the distribution with parameter n.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LaplaceDist
Computes the inverse Laplace distribution function.
inverseF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
 
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LogisticDist
Computes the inverse distribution function F-1(u).
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Computes the inverse of the log-logistic distribution with parameters α and β.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.LognormalDist
Computes the inverse of the lognormal distribution function, using NormalDist.inverseF01.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
 
inverseF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Computes the inverse of the distribution function.
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Computes the inverse function without precomputing tables.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.NormalDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Computes the inverse normal distribution function with mean μ and variance σ2.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.NormalDistQuick
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDistQuick
Returns an approximation of Φ-1(u), where Φ is the standard normal distribution function, with mean 0 and variance 1.
inverseF(double, double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
NOT IMPLEMENTED.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.ParetoDist
Computes the inverse of the distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Computes the inverse distribution function of a Pearson V distribution with shape parameter α and scale parameter β.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
 
inverseF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Computes the inverse distribution function of a Pearson VI distribution with shape parameters α1 and α2, and scale parameter β.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
 
inverseF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.PoissonDist
Performs a linear search to get the inverse function without precomputed tables.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.PowerDist
 
inverseF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.PowerDist
Computes the inverse of the distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Computes the inverse of the distribution function.
inverseF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.RayleighDist
Same as inverseF (0, beta, u).
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.StudentDist
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.StudentDist
Returns the inverse x = F-1(u) of Student t-distribution function with n degrees of freedom.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.StudentDistQuick
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.StudentDistQuick
Returns an approximation of F-1(u), where F is the Student t-distribution function with n degrees of freedom.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
 
inverseF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.TriangularDist
Computes the inverse distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
 
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.UniformDist
 
inverseF(double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.UniformDist
Computes the inverse of the uniform distribution function.
inverseF(int, int, double) - Static method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Computes the inverse of the discrete uniform distribution function.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.WatsonGDist
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.WatsonGDist
Computes x = Fn-1(u), where Fn is the Watson G distribution with parameter n.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
 
inverseF(int, double) - Static method in class umontreal.iro.lecuyer.probdist.WatsonUDist
Computes x = Fn-1(u), where Fn is the Watson U distribution with parameter n.
inverseF(double) - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
 
inverseF(double, double, double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Computes the inverse of the distribution function.
inverseF(double, double) - Static method in class umontreal.iro.lecuyer.probdist.WeibullDist
Same as inverseF (alpha, 1, 0, x).
inverseF01(double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDist
Same as inverseF (0, 1, u).
inverseF01(double) - Static method in class umontreal.iro.lecuyer.probdist.NormalDistQuick
Same as inverseF (0.0, 1.0, u).
inverseFInt(double) - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
 
inverseFInt(double) - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
 
inverseFInt(double) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
Returns the inverse distribution function F-1(u), where 0 <= u <= 1.
inverseFInt(double) - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
 
inverseFInt(double) - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
 
inverseFInt(double) - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
 
inverseFInt(double) - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
 
inverseFInt(double) - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
 
inverseFInt(double) - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
 
InverseFromDensityGen - Class in umontreal.iro.lecuyer.randvar
Implements a method for generating random variates by numerical inversion of an arbitrary continuous distribution when only the probability density is known.
InverseFromDensityGen(RandomStream, ContinuousDistribution, double, double, int) - Constructor for class umontreal.iro.lecuyer.randvar.InverseFromDensityGen
Creates a new generator for the continuous distribution dis, using stream s.
InverseFromDensityGen(RandomStream, MathFunction, double, double, int, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.InverseFromDensityGen
Creates a new generator from the continuous probability density dens.
InverseGammaDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the inverse gamma distribution with shape parameter α > 0 and scale parameter β > 0.
InverseGammaDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.InverseGammaDist
Constructs an InverseGammaDist object with parameters α = alpha and β = beta.
inverseGammaFunction(double) - Static method in class flanagan.analysis.Stat
 
InverseGammaGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the inverse gamma distribution with shape parameter α > 0 and scale parameter β > 0.
InverseGammaGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.InverseGammaGen
Creates an inverse gamma random variate generator with parameters α = alpha and β = beta, using stream s.
InverseGammaGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.InverseGammaGen
Creates an inverse gamma random variate generator with parameters α = alpha and β = 1, using stream s.
InverseGammaGen(RandomStream, InverseGammaDist) - Constructor for class umontreal.iro.lecuyer.randvar.InverseGammaGen
Creates a new generator for the distribution dist, using stream s.
inverseGaussianCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
inverseGaussianCDF(double) - Static method in class flanagan.analysis.Stat
 
InverseGaussianDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the inverse Gaussian distribution with location parameter μ > 0 and scale parameter λ > 0.
InverseGaussianDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Constructs the inverse Gaussian distribution with parameters μ and λ.
InverseGaussianGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the inverse Gaussian distribution with location parameter μ > 0 and scale parameter λ > 0.
InverseGaussianGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.InverseGaussianGen
Creates an inverse Gaussian random variate generator with parameters μ = mu and λ = lambda, using stream s.
InverseGaussianGen(RandomStream, InverseGaussianDist) - Constructor for class umontreal.iro.lecuyer.randvar.InverseGaussianGen
Creates a new generator for the distribution dist, using stream s.
InverseGaussianMSHGen - Class in umontreal.iro.lecuyer.randvar
This class implements inverse gaussian random variate generators using the many-to-one transformation method of Michael, Schucany and Haas (MHS).
InverseGaussianMSHGen(RandomStream, NormalGen, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.InverseGaussianMSHGen
Creates an inverse gaussian random variate generator with parameters μ = mu and λ = lambda, using streams s and sn.
InverseGaussianMSHGen(RandomStream, NormalGen, InverseGaussianDist) - Constructor for class umontreal.iro.lecuyer.randvar.InverseGaussianMSHGen
Creates a new generator for the distribution dist using streams s and sn.
InverseGaussianProcess - Class in umontreal.iro.lecuyer.stochprocess
The inverse Gaussian process is a non-decreasing process where the increments are additive and are given by the inverse gaussian distribution, InverseGaussianDist.
InverseGaussianProcess(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
Constructs a new InverseGaussianProcess.
InverseGaussianProcessBridge - Class in umontreal.iro.lecuyer.stochprocess
Samples the path by bridge sampling: first finding the process value at the final time and then the middle time, etc.
InverseGaussianProcessBridge(double, double, double, RandomStream, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessBridge
Constructs a new InverseGaussianProcessBridge.
InverseGaussianProcessMSH - Class in umontreal.iro.lecuyer.stochprocess
Uses a faster generating method (MSH) than the simple inversion of the distribution function used by InverseGaussianProcess.
InverseGaussianProcessMSH(double, double, double, RandomStream, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Constructs a new InverseGaussianProcessMSH.
InverseGaussianProcessPCA - Class in umontreal.iro.lecuyer.stochprocess
Approximates a principal component analysis (PCA) decomposition of the InverseGaussianProcess.
InverseGaussianProcessPCA(double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessPCA
Constructs a new InverseGaussianProcessPCA.
inverseLU(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
inverseNormalCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
inverseNormalCDF(double) - Static method in class flanagan.analysis.Stat
 
inverseParetoCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
inverseQR(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
inverseRayleighCDF(double, double) - Static method in class flanagan.analysis.Stat
 
inversetransform(double[]) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Inversely transform the given real data set.
inversetransform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform(double[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given real data set.
inversetransform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform(Complex[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given complex data set.
inversetransform(double[]) - Method in class org.apache.commons.math.transform.FastHadamardTransformer
Inversely transform the given real data set.
inversetransform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastHadamardTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform(double[]) - Method in class org.apache.commons.math.transform.FastSineTransformer
Inversely transform the given real data set.
inversetransform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastSineTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform(double[]) - Method in interface org.apache.commons.math.transform.RealTransformer
Inversely transform the given real data set.
inversetransform(UnivariateRealFunction, double, double, int) - Method in interface org.apache.commons.math.transform.RealTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform2(double[]) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Inversely transform the given real data set.
inversetransform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform2(double[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given real data set.
inversetransform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given real function, sampled on the given interval.
inversetransform2(Complex[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Inversely transform the given complex data set.
inversetransform2(double[]) - Method in class org.apache.commons.math.transform.FastSineTransformer
Inversely transform the given real data set.
inversetransform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastSineTransformer
Inversely transform the given real function, sampled on the given interval.
inverseWeibullCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
inverseWeibullCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
inverseWeibullCDF(double, double) - Static method in class flanagan.analysis.Stat
 
invert() - Method in class flanagan.analysis.Stat
 
invert() - Method in class flanagan.math.ArrayMaths
 
invert() - Method in class hephysics.matrix.BasicMatrix
 
invert() - Method in interface hephysics.matrix.MutableMatrix
Invert this matrix (into itself)
invert() - Method in class hephysics.matrix.SymmetricMatrix
 
invert() - Method in class hephysics.vec.Hep3Matrix
 
invert(double[]) - Static method in class jhplot.math.ArrayMathUtils
Inverts an array from left to right.
invert(int[]) - Static method in class jhplot.math.ArrayMathUtils
Inverts an array from left to right.
INVERT - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The invert operator wrapped as a ComposableFunction.
invertElements(double[]) - Static method in class flanagan.math.Fmath
 
invertElements(float[]) - Static method in class flanagan.math.Fmath
 
invertIndex(int[]) - Static method in class jhplot.math.Sorting
 
iparmq(int, String, String, int, int, int, int) - Method in class org.netlib.lapack.LAPACK
Purpose ======= This program sets problem and machine dependent parameters useful for xHSEQR and its subroutines.
IRAC2 - Static variable in class umontreal.iro.lecuyer.util.Num
The value of 1/(2)1/2.
isAlive() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Returns true if the process is alive, otherwise false.
isAllocated - Variable in class cern.jet.stat.Buffer
 
isAllocated() - Method in class cern.jet.stat.Buffer
Returns whether the receiver is already allocated.
isamax(int, float[], int) - Method in class org.netlib.blas.BLAS
..
IsApplet - Static variable in class jhplot.HZirkel
 
isArray() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix is in array format, else false
isArray() - Method in class cern.colt.matrix.io.VectorInfo
Returns true if the vector is in array format, else false
isArrow() - Method in class jhplot.jadraw.JaArcObject
Determines whether the arrow property of this arc object is set or not.
isArrow() - Method in class jhplot.jadraw.JaLineObject
Determines whether the arrow property of this line object is set or not.
isArrow() - Method in class jhplot.jadraw.JaLoopObject
Determines whether the arrow property of this loop object is set or not.
isAutoRange(int) - Method in class jhplot.jadraw.JaAxes
Is the graph axis were done with the aoutorange option?
isAxisShown(int) - Method in class jhplot.HPlot
Returns whether an axis line will be drawn or not.
isBack() - Method in class jhplot.jadraw.JaLineObject
Determines whether the back property of this line object is set or not.
isBars() - Method in class jhplot.DrawOptions
Return true if histogram is shown using bars.
isBetween(double, double) - Static method in class cern.jet.math.Functions
Constructs a function that returns from<=a && a<=to.
isBetween(int, int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns from<=a && a<=to.
isBetween(double, double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns from<=a && a<=to.
isBetween(float, float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns from<=a && a<=to.
isBetween(int, int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns from<=a && a<=to.
isBetween(long, long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns from<=a && a<=to.
isBiasCorrected() - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Returns true iff biasCorrected property is set to true.
isBiasCorrected() - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
 
isBiasCorrected() - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
 
isBorder() - Method in class jhplot.GHMargin
Is boarder shown?
isBorderShown() - Method in class jhplot.GHPanel
is the boarder of margins shown?
isBound() - Method in class hep.aida.ref.fitter.FitParameterSettings
 
isBound() - Method in class org.apache.commons.math.estimation.EstimatedParameter
Deprecated. Check if the parameter is bound
isBroadcasting() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Determines if this list of statistical probes is broadcasting observations to registered observers.
isBroadcasting() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Determines if this statistical probe is broadcasting observations to registered observers.
isCaching() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Determines if the random variate generator is caching values, default being true.
isCaching() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Determines if the random stream is caching values, default being true.
isCollecting() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Determines if this list of statistical probes is collecting values.
isCollecting() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Determines if this statistical probe is collecting values.
isColumnDimension(double[][], int) - Static method in class jhplot.math.DoubleArray
Same as checkColumnDimension() but just returns a boolean value rather than throwing an exception.
isComplex() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix stores complex numbers, else false
isComplex() - Method in class cern.colt.matrix.io.VectorInfo
Returns true if the vector stores complex numbers, else false
isConnected() - Method in class hep.aida.ref.event.AIDAObservable
 
isConnected() - Method in interface hep.aida.ref.event.Connectable
 
isConnected() - Method in class hep.aida.ref.event.ConnectEvent
 
isContour() - Method in class jhplot.HPlotJa
is contour plot?
isContour() - Method in class jhplot.jadraw.JaAxes
Is contour plot shown?
isContourBar() - Method in class jhplot.HPlotJa
Show a bar indicating levels on contour plot
isContourBar() - Method in class jhplot.jadraw.JaAxes
is a bar showing levels should be shown?
isConverted() - Method in class hep.aida.ref.histogram.Cloud
Check if the ICloud has been converted to an IHistogram.
isConverted() - Method in class hep.aida.ref.histogram.Cloud1D
Has the Cloud been converted to a Histogram?
isConverted() - Method in class hep.aida.ref.histogram.Cloud2D
Has the Cloud been converted to a Histogram?
isConverted() - Method in class hep.aida.ref.histogram.Cloud3D
Has the Cloud been converted to a Histogram?
isCoordinate() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix is in coordinate format, else false
isCoordinate() - Method in class cern.colt.matrix.io.VectorInfo
Returns true if the vector is in coordinate format, else false
isCopy(JaObject) - Method in class jhplot.jadraw.JaAxes
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaBlob
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaBox
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaFArc
Returns true if all serializable variables of this JaFArc and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaFLine
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaFLoop
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaGArc
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaGlArc
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaGLine
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaGlLine
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaGlLoop
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaGLoop
Returns true if all serializable variables of this JaLoopObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaKey
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaLatexText
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaLine
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaLoopObject
Returns true if all serializable variables of this JaLoopObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaObject
Determines if this JaObject is a copy of the specified one.
isCopy(JaObject) - Method in class jhplot.jadraw.JaPArc
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaPLine
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaPLoop
Returns true if all serializable variables of this JaLoopObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaSArc
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaSLine
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaSLoop
Returns true if all serializable variables of this JaLoopObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaText
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaTextBox
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaVertex
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaVertexT1
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaVertexT2
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaVertexT3
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaVertexT4
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaVertexT5
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaVertexT6
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isCopy(JaObject) - Method in class jhplot.jadraw.JaZigZagLine
Returns true if all serializable variables of this JaObject and those of the specified one are equal.
isDense() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix is in array format, else false
isDense() - Method in class cern.colt.matrix.io.VectorInfo
Returns true if the vector is in array format, else false
isDiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is diagonal if A[i,j] == 0 whenever i != j.
isDiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is diagonal if A[i,j] == 0 whenever i != j.
isDiagonal(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is diagonal if A[i,j] == 0 whenever i != j.
isDiagonal(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is diagonal if A[i,j] == 0 whenever i != j.
isDiagonal(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is diagonal if A[i,j] == 0 whenever i != j.
isDiagonal() - Method in class flanagan.math.Matrix
 
isDiagonallyDominantByColumn(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is diagonally dominant by column if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding column.
isDiagonallyDominantByColumn(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is diagonally dominant by column if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding column.
isDiagonallyDominantByColumn(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is diagonally dominant by column if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding column.
isDiagonallyDominantByColumn(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is diagonally dominant by column if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding column.
isDiagonallyDominantByColumn(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is diagonally dominant by column if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding column.
isDiagonallyDominantByRow(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is diagonally dominant by row if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding row.
isDiagonallyDominantByRow(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is diagonally dominant by row if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding row.
isDiagonallyDominantByRow(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is diagonally dominant by row if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding row.
isDiagonallyDominantByRow(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is diagonally dominant by row if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding row.
isDiagonallyDominantByRow(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is diagonally dominant by row if the absolute value of each diagonal element is larger than the sum of the absolute values of the off-diagonal elements in the corresponding row.
isEmpty() - Method in class cern.colt.list.AbstractCollection
Tests if the receiver has no elements.
isEmpty() - Method in class cern.colt.map.AbstractMap
Returns true if the receiver contains no (key,value) associations.
isEmpty() - Method in class cern.jet.stat.Buffer
Returns whether the receiver is empty.
isEmpty() - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Returns whether the receiver is empty.
isEmpty() - Method in class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Check if the manager does not manage any event handlers.
isEmpty() - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
isEmpty() - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
isEmpty() - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Returns true if and only if the event list is empty (no event is scheduled).
isEmpty() - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
isEmpty() - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
isEmpty() - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
isEmpty() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
isEnd() - Method in class jhplot.jadraw.JaArcObject
Determines whether the end property of this line object is set or not.
isEnd() - Method in class jhplot.jadraw.JaLineObject
Determines whether the end property of this line object is set or not.
isEqual - Static variable in class cern.jet.math.Functions
Function that returns a == b.
isEqual(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a == b.
isEqual - Static variable in class cern.jet.math.IntFunctions
Function that returns a == b.
isEqual(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a == b.
isEqual(double[], double[], double) - Static method in class cern.jet.math.tdcomplex.DComplex
 
isEqual - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
isEqual(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
isEqual - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a == b.
isEqual(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a == b.
isEqual(float[], float[], float) - Static method in class cern.jet.math.tfcomplex.FComplex
 
isEqual - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
isEqual(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
isEqual - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a == b.
isEqual(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a == b.
isEqual - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a == b.
isEqual(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a == b.
isEqual - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a == b.
isEqual(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a == b.
isEqual(double, double) - Static method in class flanagan.math.Fmath
 
isEqual(float, float) - Static method in class flanagan.math.Fmath
 
isEqual(int, int) - Static method in class flanagan.math.Fmath
 
isEqual(char, char) - Static method in class flanagan.math.Fmath
 
isEqual(String, String) - Static method in class flanagan.math.Fmath
 
isEqual(IFunction) - Method in class hep.aida.ref.fitter.InternalFitFunction
 
isEqual(IFunction) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
isEqual(IFunction) - Method in class hep.aida.ref.function.AbstractIFunction
 
isEqual(IFunction) - Method in class hep.aida.ref.function.BaseModelFunction
 
isEqual(IFunction) - Method in class hep.aida.ref.function.SumOfFunctions
 
isEqualWithinLimits(double, double, double) - Static method in class flanagan.math.Fmath
 
isEqualWithinLimits(float, float, float) - Static method in class flanagan.math.Fmath
 
isEqualWithinLimits(long, long, long) - Static method in class flanagan.math.Fmath
 
isEqualWithinLimits(int, int, int) - Static method in class flanagan.math.Fmath
 
isEqualWithinLimits(BigDecimal, BigDecimal, BigDecimal) - Static method in class flanagan.math.Fmath
 
isEqualWithinLimits(BigInteger, BigInteger, BigInteger) - Static method in class flanagan.math.Fmath
 
isEqualWithinPerCent(double, double, double) - Static method in class flanagan.math.Fmath
 
isEqualWithinPerCent(float, float, float) - Static method in class flanagan.math.Fmath
 
isEqualWithinPerCent(long, long, double) - Static method in class flanagan.math.Fmath
 
isEqualWithinPerCent(long, long, long) - Static method in class flanagan.math.Fmath
 
isEqualWithinPerCent(int, int, double) - Static method in class flanagan.math.Fmath
 
isEqualWithinPerCent(int, int, int) - Static method in class flanagan.math.Fmath
 
isEqualWithinPerCent(BigDecimal, BigDecimal, BigDecimal) - Static method in class flanagan.math.Fmath
 
isEqualWithinPerCent(BigInteger, BigInteger, BigDecimal) - Static method in class flanagan.math.Fmath
 
isEqualWithinPerCent(BigInteger, BigInteger, BigInteger) - Static method in class flanagan.math.Fmath
 
iset(int, int, int[], int) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
isEvaluated() - Method in class jhplot.FND
Is the function was evaluated?
isEven(int) - Static method in class flanagan.math.Fmath
 
isEven(float) - Static method in class flanagan.math.Fmath
 
isEven(double) - Static method in class flanagan.math.Fmath
 
isExists(String) - Method in class jhplot.io.HDataBase
Checks if there is a record belonging to the given key.
isFillable() - Method in class hep.aida.ref.Annotation
 
isFillable() - Method in class hep.aida.ref.ManagedObject
 
isFilled() - Method in class jhplot.FPR
Is area filled or not
isFilled() - Method in class jhplot.jadraw.JaBlob
Get the filled style
isFilled() - Method in class jhplot.jadraw.JaBox
Get the filled style
isFirst() - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
isFirst() - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Returns true for the first iteration
isFirst() - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
isFirst() - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Returns true for the first iteration
isFixed() - Method in class hep.aida.ref.fitter.FitParameterSettings
 
isFixedBinning() - Method in class hep.aida.ref.histogram.FixedAxis
 
isFixedBinning() - Method in class hep.aida.ref.histogram.VariableAxis
 
isFixedBinning() - Method in class jhplot.H1D
Return true if bins have constant bin width
isFixedBinning() - Method in class jhplot.HProf1D
Return true if bins have constant bin width
isFlip() - Method in class jhplot.jadraw.JaArcObject
Determines whether the flip property of this arc object is set or not.
isFlip() - Method in class jhplot.jadraw.JaLineObject
Determines whether the flip property of this line object is set or not.
isFlip() - Method in class jhplot.jadraw.JaLoopObject
Determines whether the flip property of this loop object is set or not.
isForward() - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Check if the natural integration direction is forward.
isForward() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Check if the natural integration direction is forward.
isForward() - Method in interface org.apache.commons.math.ode.sampling.StepInterpolator
Check if the natural integration direction is forward.
isFull() - Method in class cern.jet.stat.Buffer
Returns whether the receiver is empty.
isFull() - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Returns whether the receiver is empty.
isFullRank() - Method in class jhplot.math.QRDecomposition
Is the matrix full rank?
isGeneral() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix form is general, else false
isGreater - Static variable in class cern.jet.math.Functions
Function that returns a > b.
isGreater(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a > b.
isGreater - Static variable in class cern.jet.math.IntFunctions
Function that returns a > b.
isGreater(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a > b.
isGreater - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a > b.
isGreater(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a > b.
isGreater - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a > b.
isGreater(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a > b.
isGreater - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a > b.
isGreater(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a > b.
isGreater - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a > b.
isGreater(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a > b.
isGridFront() - Method in class jhplot.jadraw.JaAxes
is grid should be shown in front of all drawn objects?
isGridToFront() - Method in class jhplot.HPlot
Flag, saying whether the grid should be drawn at the foreground or not.
isHermitian() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix is Hermitian, else false
isIdentity(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is an identity matrix if A[i,i] == 1 and all other cells are zero.
isIdentity(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is an identity matrix if A[i,i] == 1 and all other cells are zero.
isIdentity(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is an identity matrix if A[i,i] == 1 and all other cells are zero.
isIdentity(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is an identity matrix if A[i,i] == 1 and all other cells are zero.
isIdentity(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is an identity matrix if A[i,i] == 1 and all other cells are zero.
isIdentity() - Method in class flanagan.math.Matrix
 
isIgnored() - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Deprecated. Check if this measurement should be ignored
isInfinite() - Method in class org.apache.commons.math.complex.Complex
Returns true if either the real or imaginary part of this complex number takes an infinite value (either Double.POSITIVE_INFINITY or Double.NEGATIVE_INFINITY) and neither part is NaN.
isInfinite() - Method in class org.apache.commons.math.dfp.Dfp
Check if instance is infinite.
isInfinite() - Method in class org.apache.commons.math.geometry.Vector3D
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in class org.apache.commons.math.linear.ArrayRealVector
Returns true if any coordinate of this vector is infinite and none are NaN; false otherwise
isInfinite() - Method in class org.apache.commons.math.linear.OpenMapRealVector
Check whether any coordinate of this vector is infinite and none are NaN.
isInfinite() - Method in interface org.apache.commons.math.linear.RealVector
Check whether any coordinate of this vector is infinite and none are NaN.
isInfinity(double) - Static method in class flanagan.math.Fmath
 
isInfinity(float) - Static method in class flanagan.math.Fmath
 
isInflip() - Method in class jhplot.jadraw.JaLineObject
Determines whether the inflip property of this line object is set or not.
isInMemory() - Method in class hep.aida.ref.tuple.AbstractTuple
 
isInMemory() - Method in class hep.aida.ref.tuple.ChainedTuple
 
isInMemory() - Method in interface hep.aida.ref.tuple.FTuple
 
isInMemory() - Method in class hep.aida.ref.tuple.FTupleAdapter
 
isInMemory() - Method in class hep.aida.ref.tuple.Tuple
 
isInRange(double) - Method in class hep.aida.ref.function.Range
Check if a value is within the IRange.
isInRange(double) - Method in class hep.aida.ref.function.RangeSet
 
isInteger() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix stores integers, else false
isInteger() - Method in class cern.colt.matrix.io.VectorInfo
Returns true if the vector stores integers, else false
isInteger() - Method in class flanagan.math.ArrayMaths
 
isInteger(double) - Static method in class flanagan.math.Fmath
 
isInteger(double[]) - Static method in class flanagan.math.Fmath
 
isInteger(float) - Static method in class flanagan.math.Fmath
 
isInteger(float[]) - Static method in class flanagan.math.Fmath
 
isInteger(Number) - Static method in class flanagan.math.Fmath
 
isInteger(Number[]) - Static method in class flanagan.math.Fmath
 
isLength(double[], int) - Static method in class jhplot.math.DoubleArray
Same as checkLength but returns a boolean value rather than throwing an exception.
isLess - Static variable in class cern.jet.math.Functions
Function that returns a < b.
isLess(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a < b.
isLess - Static variable in class cern.jet.math.IntFunctions
Function that returns a < b.
isLess(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a < b.
isLess - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a < b.
isLess(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a < b.
isLess - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a < b.
isLess(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a < b.
isLess - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a < b.
isLess(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a < b.
isLess - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a < b.
isLess(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a < b.
isLightlike(double) - Method in class hephysics.vec.HepLorentzVector
is spacelike?
isLoaded() - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Property indicating whether or not the distribution has been loaded.
isLoaded() - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Property indicating whether or not the distribution has been loaded.
isLogScale(int) - Method in class jhplot.jadraw.JaAxes
 
isLowerBidiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is lower bidiagonal if A[i,j]==0 unless i==j || i==j+1.
isLowerBidiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is lower bidiagonal if A[i,j]==0 unless i==j || i==j+1.
isLowerBidiagonal(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is lower bidiagonal if A[i,j]==0 unless i==j || i==j+1.
isLowerBidiagonal(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is lower bidiagonal if A[i,j]==0 unless i==j || i==j+1.
isLowerBidiagonal(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is lower bidiagonal if A[i,j]==0 unless i==j || i==j+1.
isLowerHessenberg() - Method in class flanagan.math.Matrix
 
isLowerTriagonal() - Method in class flanagan.math.Matrix
 
isLowerTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is lower triangular if A[i,j]==0 whenever i < j.
isLowerTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is lower triangular if A[i,j]==0 whenever i < j.
isLowerTriangular(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is lower triangular if A[i,j]==0 whenever i < j.
isLowerTriangular(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is lower triangular if A[i,j]==0 whenever i < j.
isLowerTriangular(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is lower triangular if A[i,j]==0 whenever i < j.
isMarked() - Method in class jhplot.jadraw.JaObject
Determines whether this JaObject is marked as an element of a group or not.
isMeanAndRmsSet() - Method in class hep.aida.ref.histogram.Histogram
 
isMinusInfinity(double) - Static method in class flanagan.math.Fmath
 
isMinusInfinity(float) - Static method in class flanagan.math.Fmath
 
isMirrorAxisShown(int) - Method in class jhplot.HPlot
Returns whether the mirror of an axis will be drawn or not.
isModifiable() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Determines if this list of statistical probes is modifiable, i.e., if probes can be added or removed.
isMultiline() - Method in class jhplot.jadraw.JaTextBox
Is this multiline text?
isNaN(double) - Static method in class flanagan.math.Fmath
 
isNaN(float) - Static method in class flanagan.math.Fmath
 
isNaN() - Method in class org.apache.commons.math.complex.Complex
Returns true if either or both parts of this complex number is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math.dfp.Dfp
Check if instance is not a number.
isNaN() - Method in class org.apache.commons.math.geometry.Vector3D
Returns true if any coordinate of this vector is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math.linear.ArrayRealVector
Returns true if any coordinate of this vector is NaN; false otherwise
isNaN() - Method in class org.apache.commons.math.linear.OpenMapRealVector
Check whether any coordinate of this vector is NaN.
isNaN() - Method in interface org.apache.commons.math.linear.RealVector
Check whether any coordinate of this vector is NaN.
isNearlyIdenty(double) - Method in class flanagan.math.Matrix
 
isNearlyLowerHessenberg(double) - Method in class flanagan.math.Matrix
 
isNearlyLowerTriagonal(double) - Method in class flanagan.math.Matrix
 
isNearlySymmetric(double) - Method in class flanagan.math.Matrix
 
isNearlyUnit(double) - Method in class flanagan.math.Matrix
 
isNearlyUpperHessenberg(double) - Method in class flanagan.math.Matrix
 
isNearlyUpperTriagonal(double) - Method in class flanagan.math.Matrix
 
isNearlyZero(double) - Method in class flanagan.math.Matrix
 
isNoIntercept() - Method in class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
 
isNonNegative(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is non-negative if A[i,j] >= 0 holds for all cells.
isNonNegative(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is non-negative if A[i,j] >= 0 holds for all cells.
isNonNegative(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is non-negative if A[i,j] >= 0 holds for all cells.
isNonNegative(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is non-negative if A[i,j] >= 0 holds for all cells.
isNonNegative(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is non-negative if A[i,j] >= 0 holds for all cells.
isNonsingular() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns whether the matrix is nonsingular (has an inverse).
isNonsingular() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns whether the matrix is nonsingular (has an inverse).
isNonsingular() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecomposition
Returns whether the matrix is nonsingular (has an inverse).
isNonsingular() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Returns whether the matrix is nonsingular (has an inverse).
isNonsingular() - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleLUDecomposition
Returns whether the matrix is nonsingular (has an inverse).
isNonsingular() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecomposition
Returns whether the matrix is nonsingular (has an inverse).
isNonsingular() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Returns whether the matrix is nonsingular (has an inverse).
isNonsingular() - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatLUDecomposition
Returns whether the matrix is nonsingular (has an inverse).
isNonsingular() - Method in class jhplot.math.LUDecomposition
Is the matrix nonsingular?
isNonSingular() - Method in interface org.apache.commons.math.linear.DecompositionSolver
Check if the decomposed matrix is non-singular.
isNonSingular() - Method in interface org.apache.commons.math.linear.FieldDecompositionSolver
Check if the decomposed matrix is non-singular.
isNormalized() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
isNormalized() - Method in class hep.aida.ref.function.AbstractIFunction
 
isNormalized() - Method in class hep.aida.ref.function.BaseModelFunction
 
IsObservable - Interface in hep.aida.ref.event
An interface to be implemented by AIDA objects that can notify observers of change to their state.
isOdd(int) - Static method in class flanagan.math.Fmath
 
isOdd(float) - Static method in class flanagan.math.Fmath
 
isOdd(double) - Static method in class flanagan.math.Fmath
 
isOrthogonal(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A square matrix A is orthogonal if A*transpose(A) = I.
isOrthogonal(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A square matrix A is orthogonal if A*transpose(A) = I.
isOrthogonal(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A square matrix A is orthogonal if A*transpose(A) = I.
isOrthogonal(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A square matrix A is orthogonal if A*transpose(A) = I.
isOrthogonal(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A square matrix A is orthogonal if A*transpose(A) = I.
isPartial() - Method in class cern.jet.stat.Buffer
Returns whether the receiver is partial.
isPathInDir(String, String) - Static method in class hep.aida.ref.AidaUtils
 
isPattern() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix does not store any numbers, else false
isPattern() - Method in class cern.colt.matrix.io.VectorInfo
Returns true if the vector does not store any numbers, else false
isPlusInfinity(double) - Static method in class flanagan.math.Fmath
 
isPlusInfinity(float) - Static method in class flanagan.math.Fmath
 
isPositive(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is positive if A[i,j] > 0 holds for all cells.
isPositive(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is positive if A[i,j] > 0 holds for all cells.
isPositive(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is positive if A[i,j] > 0 holds for all cells.
isPositive(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is positive if A[i,j] > 0 holds for all cells.
isPositive(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is positive if A[i,j] > 0 holds for all cells.
isPowerOf2(long) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Returns true if the argument is power of 2.
isPrimitivesToFront() - Method in class jhplot.HPlot
Flag, saying whether primitives should be drawn at the foreground or not.
isReadOnly() - Method in class hep.aida.ref.tree.Tree
 
isReal() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix stores real numbers, else false
isReal() - Method in class cern.colt.matrix.io.VectorInfo
Returns true if the vector stores real numbers, else false
isRebinnable() - Method in class cern.hep.aida.bin.AbstractBin
Returns whether a client can obtain all elements added to the receiver.
isRebinnable() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns true.
isRebinnable() - Method in class cern.hep.aida.bin.StaticBin1D
Returns false.
isRebinnable() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns whether a client can obtain all elements added to the receiver.
isRebinnable() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns true.
isRebinnable() - Method in class hep.aida.tdouble.bin.StaticDoubleBin1D
Returns false.
isRebinnable() - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns whether a client can obtain all elements added to the receiver.
isRebinnable() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns true.
isRebinnable() - Method in class hep.aida.tfloat.bin.StaticFloatBin1D
Returns false.
isResizing() - Method in class jhplot.jadraw.JaArcObject
Returns the resizing property of this arc.
isRolledOver(int, int) - Method in class jhplot.jadraw.JaLatexText
Determines whether the curser is currently above the visual aid icon of this LatexText.
isRowDimension(double[][], int) - Static method in class jhplot.math.DoubleArray
Same as checkRowDimension() but just returns a boolean value rather than throwing an exception.
isSatisfied(Population) - Method in class org.apache.commons.math.genetics.FixedGenerationCount
Determine whether or not the given number of generations have passed.
isSatisfied(Population) - Method in interface org.apache.commons.math.genetics.StoppingCondition
Determine whether or not the given population satisfies the stopping condition.
isShadow() - Method in class jhplot.jadraw.JaTextBox
Is box with shadow?
isShow(int) - Method in class jhplot.jadraw.JaAxes
Is a particular axis should be shown?
isShowGrid(int) - Method in class jhplot.jadraw.JaAxes
Is grid to be shown?
isShowKey() - Method in class jhplot.jadraw.JaAxes
is key should be shown?
isShowMirror(int) - Method in class jhplot.jadraw.JaAxes
Is axis mirror is shown?
isShowStatBox() - Method in class jhplot.HPlotJa
Is stat box is shown on the current pad?
isSimulating() - Method in class umontreal.iro.lecuyer.simevents.Simulator
Determines if this simulator is currently running, i.e., executing scheduled events.
isSingular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is singular if it has no inverse, that is, iff det(A)==0.
isSingular(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is singular if it has no inverse, that is, iff det(A)==0.
isSingular(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is singular if it has no inverse, that is, iff det(A)==0.
isSingular() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Deprecated. 
isSingular() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Is this a singular matrix?
isSingular() - Method in interface org.apache.commons.math.linear.RealMatrix
Deprecated. as of release 2.0, replaced by the boolean negation of new LUDecompositionImpl(m).getSolver().isNonSingular()
isSkewSymmetric() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix is skew-symmetrical, else false
isSkewSymmetric(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A square matrix A is skew-symmetric if A = -transpose(A), that is A[i,j] == -A[j,i].
isSkewSymmetric(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A square matrix A is skew-symmetric if A = -transpose(A), that is A[i,j] == -A[j,i].
isSkewSymmetric(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A square matrix A is skew-symmetric if A = -transpose(A), that is A[i,j] == -A[j,i].
isSkewSymmetric(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A square matrix A is skew-symmetric if A = -transpose(A), that is A[i,j] == -A[j,i].
isSkewSymmetric(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A square matrix A is skew-symmetric if A = -transpose(A), that is A[i,j] == -A[j,i].
isSorted - Variable in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
 
isSortedFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Determines whether the receiver is sorted ascending, according to the natural ordering of its elements.
isSortedFromTo(int, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Determines whether the receiver is sorted ascending, according to the natural ordering of its elements.
isSpacelike() - Method in class hephysics.vec.HepLorentzVector
Is particle spacelike (i.e restMass2() smaller than 0)
isSparse() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix is in coordinate format, else false
isSparse() - Method in class cern.colt.matrix.io.VectorInfo
Returns true if the vector is in coordinate format, else false
isSPD() - Method in class jhplot.math.CholeskyDecomposition
Is the matrix symmetric and positive definite?
isSquare() - Method in class cern.colt.matrix.io.MatrixSize
Returns true if the matrix is square, else false
isSquare(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is square if it has the same number of rows and columns.
isSquare(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is square if it has the same number of rows and columns.
isSquare(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is square if it has the same number of rows and columns.
isSquare(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is square if it has the same number of rows and columns.
isSquare(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is square if it has the same number of rows and columns.
isSquare() - Method in class flanagan.math.Matrix
 
isSquare(double[][]) - Static method in class jhplot.math.ArrayMathUtils
 
isSquare(float[][]) - Static method in class jhplot.math.ArrayMathUtils
 
isSquare(long[][]) - Static method in class jhplot.math.ArrayMathUtils
 
isSquare(int[][]) - Static method in class jhplot.math.ArrayMathUtils
 
isSquare(Object[][]) - Static method in class jhplot.math.ArrayMathUtils
 
isSquare() - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Is this a square matrix?
isSquare() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Is this a square matrix?
isSquare() - Method in interface org.apache.commons.math.linear.AnyMatrix
Is this a square matrix?
isSquare() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Is this a square matrix?
isSticky(String) - Method in class hep.aida.ref.Annotation
Get the stickyness for a given key.
isSticky(int) - Method in class hep.aida.ref.Annotation
Get the stickyness corresponding to the item in a give position in the Annotation.
isStopped() - Method in class umontreal.iro.lecuyer.simevents.Simulator
Determines if this simulator was stopped by an event.
isStrictlyLowerTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is strictly lower triangular if A[i,j]==0 whenever i <= j.
isStrictlyLowerTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is strictly lower triangular if A[i,j]==0 whenever i <= j.
isStrictlyLowerTriangular(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is strictly lower triangular if A[i,j]==0 whenever i <= j.
isStrictlyLowerTriangular(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is strictly lower triangular if A[i,j]==0 whenever i <= j.
isStrictlyLowerTriangular(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is strictly lower triangular if A[i,j]==0 whenever i <= j.
isStrictlyTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is strictly triangular if it is triangular and its diagonal elements all equal 0.
isStrictlyTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is strictly triangular if it is triangular and its diagonal elements all equal 0.
isStrictlyTriangular(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is strictly triangular if it is triangular and its diagonal elements all equal 0.
isStrictlyTriangular(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is strictly triangular if it is triangular and its diagonal elements all equal 0.
isStrictlyTriangular(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is strictly triangular if it is triangular and its diagonal elements all equal 0.
isStrictlyUpperTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is strictly upper triangular if A[i,j]==0 whenever i >= j.
isStrictlyUpperTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is strictly upper triangular if A[i,j]==0 whenever i >= j.
isStrictlyUpperTriangular(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is strictly upper triangular if A[i,j]==0 whenever i >= j.
isStrictlyUpperTriangular(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is strictly upper triangular if A[i,j]==0 whenever i >= j.
isStrictlyUpperTriangular(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is strictly upper triangular if A[i,j]==0 whenever i >= j.
isSupportLowerBoundInclusive() - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
Use this method to get information about whether the lower bound of the support is inclusive or not.
isSupportUpperBoundInclusive() - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
Use this method to get information about whether the upper bound of the support is inclusive or not.
isSurface() - Method in class jhplot.HPlot3D
Is the plot will be shown as a surface?
isSymm() - Method in class jhplot.jadraw.JaLineObject
Determines whether the symm property of this line object is set or not.
isSymmetric() - Method in class cern.colt.matrix.io.MatrixInfo
Returns true if the matrix is symmetrical, else false
isSymmetric(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is symmetric if A = tranpose(A), that is A[i,j] == A[j,i].
isSymmetric(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is symmetric if A = tranpose(A), that is A[i,j] == A[j,i].
isSymmetric(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is symmetric if A = tranpose(A), that is A[i,j] == A[j,i].
isSymmetric(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is symmetric if A = tranpose(A), that is A[i,j] == A[j,i].
isSymmetric(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is symmetric if A = tranpose(A), that is A[i,j] == A[j,i].
isSymmetric() - Method in class flanagan.math.Matrix
 
isSymmetricPositiveDefinite() - Method in class cern.colt.matrix.linalg.CholeskyDecomposition
Returns whether the matrix A is symmetric and positive definite.
isSymmetricPositiveDefinite() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatCholeskyDecomposition
Returns whether the matrix A is symmetric and positive definite.
isTicksLabels(int) - Method in class jhplot.jadraw.JaAxes
Is ticks should be drawn
isTicLabelsShown(int) - Method in class jhplot.HPlot
Returns whether or not to draw the tick labels
isTicsShown(int) - Method in class jhplot.HPlot
Returns whether or not to draw ticks (little lines on the axes).
isTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is triangular iff it is either upper or lower triangular.
isTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is triangular iff it is either upper or lower triangular.
isTriangular(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is triangular iff it is either upper or lower triangular.
isTriangular(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is triangular iff it is either upper or lower triangular.
isTriangular(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is triangular iff it is either upper or lower triangular.
isTridiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is tridiagonal if A[i,j]==0 whenever Math.abs(i-j) > 1.
isTridiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is tridiagonal if A[i,j]==0 whenever Math.abs(i-j) > 1.
isTridiagonal(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is tridiagonal if A[i,j]==0 whenever Math.abs(i-j) > 1.
isTridiagonal(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is tridiagonal if A[i,j]==0 whenever Math.abs(i-j) > 1.
isTridiagonal(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is tridiagonal if A[i,j]==0 whenever Math.abs(i-j) > 1.
isTridiagonal() - Method in class flanagan.math.Matrix
 
isTridiagonal(double) - Method in class flanagan.math.Matrix
 
isUnit() - Method in class flanagan.math.Matrix
 
isUnitTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is unit triangular if it is triangular and its diagonal elements all equal 1.
isUnitTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is unit triangular if it is triangular and its diagonal elements all equal 1.
isUnitTriangular(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is unit triangular if it is triangular and its diagonal elements all equal 1.
isUnitTriangular(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is unit triangular if it is triangular and its diagonal elements all equal 1.
isUnitTriangular(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is unit triangular if it is triangular and its diagonal elements all equal 1.
isUpperBidiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is upper bidiagonal if A[i,j]==0 unless i==j || i==j-1.
isUpperBidiagonal(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is upper bidiagonal if A[i,j]==0 unless i==j || i==j-1.
isUpperBidiagonal(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is upper bidiagonal if A[i,j]==0 unless i==j || i==j-1.
isUpperBidiagonal(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is upper bidiagonal if A[i,j]==0 unless i==j || i==j-1.
isUpperBidiagonal(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is upper bidiagonal if A[i,j]==0 unless i==j || i==j-1.
isUpperHessenberg() - Method in class flanagan.math.Matrix
 
isUpperTriagonal() - Method in class flanagan.math.Matrix
 
isUpperTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is upper triangular if A[i,j]==0 whenever i > j.
isUpperTriangular(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is upper triangular if A[i,j]==0 whenever i > j.
isUpperTriangular(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is upper triangular if A[i,j]==0 whenever i > j.
isUpperTriangular(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is upper triangular if A[i,j]==0 whenever i > j.
isUpperTriangular(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is upper triangular if A[i,j]==0 whenever i > j.
isUser() - Method in class jhplot.jadraw.JaObject
Set to true if coordinates were set using USER coordinate system attached to axes
isValid() - Method in class hep.aida.ref.fitter.FitResult
 
isValid() - Method in class hep.aida.ref.function.Grid
 
isValidDouble(double) - Static method in class hep.aida.ref.histogram.binner.BinnerMath
 
isValidDouble(double) - Static method in class hep.aida.ref.histogram.HistUtils
 
isView() - Method in class cern.colt.matrix.AbstractMatrix
Returns whether the receiver is a view or not.
iswap(int, int[], int, int[], int) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
isZero(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
A matrix A is zero if all its cells are zero.
isZero(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
A matrix A is zero if all its cells are zero.
isZero(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
A matrix A is zero if all its cells are zero.
isZero(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
A matrix A is zero if all its cells are zero.
isZero(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
A matrix A is zero if all its cells are zero.
isZero() - Method in class flanagan.math.Matrix
 
itemIndex(String) - Method in class flanagan.analysis.Scores
 
itemName(int) - Method in class flanagan.analysis.Scores
 
itemNames() - Method in class flanagan.analysis.Scores
 
iterate(IterativeMethod.IterativeState) - Method in class jhplot.math.num.IterativeMethod
Perform the iterative evaluation.
iterate() - Method in interface jhplot.math.num.IterativeMethod.IterativeState
Perform the next iteration of the iterative evaluation.
iterateSpacings(DoubleArrayList, DoubleArrayList) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Applies one iteration of the iterated spacings transformation.
iterations() - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
iterations() - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Number of iterations performed
iterations() - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
 
iterations() - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
iterations() - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Number of iterations performed
iterations() - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
 
IterativeMethod - Class in jhplot.math.num
A method to solve generic problems by finding successive (and hopefully better) approximations to the solution.
IterativeMethod.IterativeState - Interface in jhplot.math.num
The current state for an iterative method.
IterativeSolverDoubleNotConvergedException - Exception in cern.colt.matrix.tdouble.algo.solver
Exception for lack of convergence in a linear problem.
IterativeSolverDoubleNotConvergedException(DoubleNotConvergedException.Reason, String, DoubleIterationMonitor) - Constructor for exception cern.colt.matrix.tdouble.algo.solver.IterativeSolverDoubleNotConvergedException
Constructor for IterativeSolverNotConvergedException
IterativeSolverDoubleNotConvergedException(DoubleNotConvergedException.Reason, DoubleIterationMonitor) - Constructor for exception cern.colt.matrix.tdouble.algo.solver.IterativeSolverDoubleNotConvergedException
Constructor for IterativeSolverNotConvergedException
IterativeSolverFloatNotConvergedException - Exception in cern.colt.matrix.tfloat.algo.solver
Exception for lack of convergence in a linear problem.
IterativeSolverFloatNotConvergedException(FloatNotConvergedException.Reason, String, FloatIterationMonitor) - Constructor for exception cern.colt.matrix.tfloat.algo.solver.IterativeSolverFloatNotConvergedException
Constructor for IterativeSolverNotConvergedException
IterativeSolverFloatNotConvergedException(FloatNotConvergedException.Reason, FloatIterationMonitor) - Constructor for exception cern.colt.matrix.tfloat.algo.solver.IterativeSolverFloatNotConvergedException
Constructor for IterativeSolverNotConvergedException
iterator() - Method in class org.apache.commons.math.genetics.ListPopulation
Chromosome list iterator
iterator() - Method in class org.apache.commons.math.linear.AbstractRealVector
Generic dense iterator.
iterator() - Method in interface org.apache.commons.math.linear.RealVector
Generic dense iterator.
iterator() - Method in class org.apache.commons.math.util.MultidimensionalCounter
Create an iterator over this counter.
iterator() - Method in class org.apache.commons.math.util.OpenIntToDoubleHashMap
Get an iterator over map elements.
iterator() - Method in class org.apache.commons.math.util.OpenIntToFieldHashMap
Get an iterator over map elements.
iterator() - Method in class umontreal.iro.lecuyer.hups.AntitheticPointSet
 
iterator() - Method in class umontreal.iro.lecuyer.hups.BakerTransformedPointSet
 
iterator() - Method in class umontreal.iro.lecuyer.hups.ContainerPointSet
 
iterator() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet
 
iterator() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2
 
iterator() - Method in class umontreal.iro.lecuyer.hups.DigitalNet
 
iterator() - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
iterator() - Method in class umontreal.iro.lecuyer.hups.PaddedPointSet
 
iterator() - Method in class umontreal.iro.lecuyer.hups.PointSet
Constructs and returns a point set iterator.
iterator() - Method in class umontreal.iro.lecuyer.hups.RandShiftedPointSet
 
iterator() - Method in class umontreal.iro.lecuyer.hups.Rank1Lattice
 
iterator() - Method in class umontreal.iro.lecuyer.hups.SubsetOfPointSet
 
iterator() - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
iterator() - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
iterator() - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
iterator() - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
iterator() - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
iterator() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
 
iterator() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
iterator() - Method in class umontreal.iro.lecuyer.util.TransformingList
 
iteratorNoGray() - Method in class umontreal.iro.lecuyer.hups.DigitalNet
This iterator does not use the Gray code.
iteratorNoGray() - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
This iterator does not use the Gray code.
iteratorShift() - Method in class umontreal.iro.lecuyer.hups.DigitalSequence
Similar to iterator, except that the first coordinate of the points is i/n, the second coordinate is obtained via the generating matrix C0, the next one via C1, and so on.
iteratorShift() - Method in class umontreal.iro.lecuyer.hups.DigitalSequenceBase2
Similar to iterator, except that the first coordinate of the points is i/n, the second coordinate is obtained via the generating matrix C0, the next one via C1, and so on.
iteratorShiftNoGray() - Method in class umontreal.iro.lecuyer.hups.DigitalSequence
This iterator shifts all coordinates of each point one position to the right and sets the first coordinate of point i to i/n, so that the points enumerated with this iterator have one more dimension.
iteratorShiftNoGray() - Method in class umontreal.iro.lecuyer.hups.DigitalSequenceBase2
This iterator shifts all coordinates of each point one position to the right and sets the first coordinate of point i to i/n, so that the points enumerated with this iterator have one more dimension.
iterPowRatioTests(DoubleArrayList, int, boolean, boolean, PrintWriter) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Similar to iterSpacingsTests, but with the GofStat.powerRatios transformation.
iterSpacingsTests(DoubleArrayList, int, boolean, boolean, PrintWriter) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Repeats the following k times: Applies the GofStat.iterateSpacings transformation to the U(0),..., U(N-1), assuming that these observations are in sortedData, then computes the EDF test statistics and calls activeTests after each transformation.
IView - Class in jhplot
Simple image viewer for PNG, JPG, GIF files
IView() - Constructor for class jhplot.IView
Show an empty image viewer.
IView(String) - Constructor for class jhplot.IView
Show image or images
ivout(int, int, int[], int, String) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.

J

j0(double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the first kind of order 0 of the argument.
j0(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the Bessel function of the first kind of order 0 of the argument.
j1(double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the first kind of order 1 of the argument.
j1(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the Bessel function of the first kind of order 1 of the argument.
JaArcObject - Class in jhplot.jadraw
The mother of all arc objects.
JaArcObject() - Constructor for class jhplot.jadraw.JaArcObject
Constructor: sets the width, height, relative width and height, to a default value of JaObject.INIT_SIZE.
JaAxes - Class in jhplot.jadraw
Main class to build a pad with axes, ticks, labels.
JaAxes(int, int) - Constructor for class jhplot.jadraw.JaAxes
Constructor: sets the width, height, getRelw() and getRelh() to a default value of 25.
JaBlob - Class in jhplot.jadraw
A blob object: a general ellypse that can be rotated.
JaBlob() - Constructor for class jhplot.jadraw.JaBlob
Constructor: sets the width, height, getRelw() and getRelh() to a default value of 25.
JaBox - Class in jhplot.jadraw
A box object.
JaBox() - Constructor for class jhplot.jadraw.JaBox
Constructor: sets the width, height, getRelw() and getRelh() to a default value of 25.
JaBox(double, double, double, double, String) - Constructor for class jhplot.jadraw.JaBox
Build a box.
jacobian() - Method in interface org.apache.commons.math.analysis.DifferentiableMultivariateVectorialFunction
Returns the jacobian function.
JaFArc - Class in jhplot.jadraw
A fermion arc.
JaFArc() - Constructor for class jhplot.jadraw.JaFArc
Constructor: just calls super().
JaFillObject - Class in jhplot.jadraw
A general object that can be filled.
JaFillObject() - Constructor for class jhplot.jadraw.JaFillObject
 
JaFLine - Class in jhplot.jadraw
A fermion line.
JaFLine() - Constructor for class jhplot.jadraw.JaFLine
Constructor: calls super() and initializes inflip to false.
JaFLoop - Class in jhplot.jadraw
A fermion loop.
JaFLoop() - Constructor for class jhplot.jadraw.JaFLoop
Constructor: just calls super().
JaGArc - Class in jhplot.jadraw
A ghost arc.
JaGArc() - Constructor for class jhplot.jadraw.JaGArc
Constructor: just calls super().
JaGlArc - Class in jhplot.jadraw
A gluon arc.
JaGlArc() - Constructor for class jhplot.jadraw.JaGlArc
Constructor: calls super() and initializes the stangle to 0.
JaGLine - Class in jhplot.jadraw
A ghost line.
JaGLine() - Constructor for class jhplot.jadraw.JaGLine
Constructor: calls super() and initializes inflip to false.
JaGlLine - Class in jhplot.jadraw
Class to build a gluon line
JaGlLine() - Constructor for class jhplot.jadraw.JaGlLine
Constructor: just calls super().
JaGlLoop - Class in jhplot.jadraw
Gluon loop
JaGlLoop() - Constructor for class jhplot.jadraw.JaGlLoop
Constructor: just calls super().
JaGLoop - Class in jhplot.jadraw
A ghost loop.
JaGLoop() - Constructor for class jhplot.jadraw.JaGLoop
Constructor: just calls super().
JaKey - Class in jhplot.jadraw
Defines a key with the text
JaKey() - Constructor for class jhplot.jadraw.JaKey
Constructor: sets the width, height, relative width and height to a default value of 2.
JaKey(int, String, double, double, String) - Constructor for class jhplot.jadraw.JaKey
Build a line
JaLatexText - Class in jhplot.jadraw
Defines a JaObject which is just a string.
JaLatexText() - Constructor for class jhplot.jadraw.JaLatexText
Constructor: sets the width, height, relative width and height to a default value of 3.
JaLine - Class in jhplot.jadraw
Build a simple line
JaLine(double, double, double, double, String) - Constructor for class jhplot.jadraw.JaLine
Build a line
JaLine() - Constructor for class jhplot.jadraw.JaLine
Constructor: calls super() and initializes inflip to false.
JaLineObject - Class in jhplot.jadraw
A general line object.
JaLineObject() - Constructor for class jhplot.jadraw.JaLineObject
Constructor: sets the width, height, relative width and height, to a default value of JaObject.INIT_SIZE.
JaLoopObject - Class in jhplot.jadraw
A general loop object.
JaLoopObject() - Constructor for class jhplot.jadraw.JaLoopObject
Constructor: sets the width, height, relative width and height, to a default value of JaObject.INIT_SIZE.
JaObject - Class in jhplot.jadraw
A general JaObject.
JaObject() - Constructor for class jhplot.jadraw.JaObject
 
JaPArc - Class in jhplot.jadraw
A photon arc.
JaPArc() - Constructor for class jhplot.jadraw.JaPArc
Constructor: calls super() and initializes the stangle to 0.
JaPLine - Class in jhplot.jadraw
A photon line.
JaPLine() - Constructor for class jhplot.jadraw.JaPLine
Constructor: just calls super().
JaPLoop - Class in jhplot.jadraw
A photon loop.
JaPLoop() - Constructor for class jhplot.jadraw.JaPLoop
Constructor: just calls super().
JaSArc - Class in jhplot.jadraw
A scalar arc.
JaSArc() - Constructor for class jhplot.jadraw.JaSArc
Constructor: just calls super().
JaSLine - Class in jhplot.jadraw
A scalar line.
JaSLine() - Constructor for class jhplot.jadraw.JaSLine
Constructor: calls super() and initializes inflip to false.
JaSLoop - Class in jhplot.jadraw
A scalar loop.
JaSLoop() - Constructor for class jhplot.jadraw.JaSLoop
Constructor: just calls super().
JaText - Class in jhplot.jadraw
Defines a JaObject which is a postscript text.
JaText() - Constructor for class jhplot.jadraw.JaText
Constructor: sets the width, height, relative width and height to a default value of 2.
JaText(String, double, double, String) - Constructor for class jhplot.jadraw.JaText
Build a text label
JaTextBox - Class in jhplot.jadraw
Text label which can be either one text line or multiline.
JaTextBox() - Constructor for class jhplot.jadraw.JaTextBox
Constructor: sets the width, height, getRelw() and getRelh() to a default value of 25.
JAVA_CLASSPATH - Static variable in class jhplot.HPlotJa
The current Java class path.
JAVA_HOME - Static variable in class jhplot.HPlotJa
The directory where Java is installed on the current machine.
JAVA_RUNTIME_VERSION - Static variable in class jhplot.HPlotJa
The current Java runtime version.
JAVA_VERSION - Static variable in class jhplot.HPlotJa
The current Java version.
JaVertex - Class in jhplot.jadraw
A vertex object.
JaVertex() - Constructor for class jhplot.jadraw.JaVertex
Constructor: sets the width, height, relative width and height, and stroke to a default value of 2.
JaVertexT1 - Class in jhplot.jadraw
A vertex (a filled circle).
JaVertexT1() - Constructor for class jhplot.jadraw.JaVertexT1
Constructor: just calls super().
JaVertexT2 - Class in jhplot.jadraw
A vertex type 2 object (a cross with a circle).
JaVertexT2() - Constructor for class jhplot.jadraw.JaVertexT2
Constructor: sets the width, height, relative width and height to a default value of 3 and initializes the firsttime variable to true.
JaVertexT3 - Class in jhplot.jadraw
A vertex (a filled square).
JaVertexT3() - Constructor for class jhplot.jadraw.JaVertexT3
Constructor: just calls super().
JaVertexT4 - Class in jhplot.jadraw
A vertex (a cross).
JaVertexT4() - Constructor for class jhplot.jadraw.JaVertexT4
Constructor: sets the width, height, relative width and height to a default value of 3 and initializes the firsttime variable to true.
JaVertexT5 - Class in jhplot.jadraw
A vertex (a triangle).
JaVertexT5() - Constructor for class jhplot.jadraw.JaVertexT5
Constructor: sets the width, height, relative width and height to a default value of 5 .
JaVertexT6 - Class in jhplot.jadraw
A vertex (a filled diamond).
JaVertexT6() - Constructor for class jhplot.jadraw.JaVertexT6
Constructor: just calls super().
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaAxes
The method that draws this Jaxo Axes.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaBlob
The method that draws this JaBlob.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaBox
The method that draws this Label.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaFArc
The method that draws this JaFArc.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaFLine
The method that draws this JaFLine.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaFLoop
The method that draws this JaFLoop.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaGArc
The method that draws this JaGArc.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaGlArc
The method that draws this JaGlArc.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaGLine
The method that draws this JaGLine.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaGlLine
The method that draws this JaGlLine.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaGlLoop
The method that draws this JaGlLoop.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaGLoop
The method that draws this JaGLoop.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaKey
The method that draws this label.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaLatexText
The method that draws this JaxoText.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaLine
The method that draws this JaFLine.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaObject
The method that draws the JaObject.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaPArc
The method that draws this JaPArc.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaPLine
The method that draws this JaPLine.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaPLoop
The method that draws this JaPLoop.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaSArc
The method that draws this JaSArc.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaSLine
The method that draws this JaSLine.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaSLoop
The method that draws this JaSLoop.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaText
The method that draws this label.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaTextBox
The method that draws this Label.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaVertex
The method that draws the JaObject.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaVertexT1
The method that draws this JaVertexT1.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaVertexT2
The method that draws this JaVertexT2.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaVertexT3
The method that draws this JaVertexT3.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaVertexT4
The method that draws this JaVertexT4.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaVertexT5
The method that draws this JaVertexT5.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaVertexT6
The method that draws this JaVertexT6.
jaxoDraw(VectorGraphics, boolean) - Method in class jhplot.jadraw.JaZigZagLine
The method that draws this JaZigZagLine.
JaZigZagLine - Class in jhplot.jadraw
A zig-zag line.
JaZigZagLine() - Constructor for class jhplot.jadraw.JaZigZagLine
Constructor: just calls super().
JDBCManager - Class in umontreal.iro.lecuyer.util
This class provides some facilities to connect to a SQL database and to retrieve data stored in it.
JDBCManager() - Constructor for class umontreal.iro.lecuyer.util.JDBCManager
 
JDKRandomGenerator - Class in org.apache.commons.math.random
Extension of java.util.Random to implement RandomGenerator.
JDKRandomGenerator() - Constructor for class org.apache.commons.math.random.JDKRandomGenerator
 
JELBaseModelFunction - Class in hep.aida.ref.function
 
JELBaseModelFunction(String, int, String, String, String, String) - Constructor for class hep.aida.ref.function.JELBaseModelFunction
 
JELCompiledExpression - Class in hep.aida.ref.function
 
JELCompiledExpression(int, int, String, String[]) - Constructor for class hep.aida.ref.function.JELCompiledExpression
 
JELCompiledExpression.Resolver - Class in hep.aida.ref.function
 
JELCompiledExpression.Resolver() - Constructor for class hep.aida.ref.function.JELCompiledExpression.Resolver
 
JELCompiledExpression.ValueProvider - Class in hep.aida.ref.function
 
JELCompiledExpression.ValueProvider(int, int) - Constructor for class hep.aida.ref.function.JELCompiledExpression.ValueProvider
 
JELFunctionCore - Class in hep.aida.ref.function
 
JELFunctionCore(int, int, String, String[], String[]) - Constructor for class hep.aida.ref.function.JELFunctionCore
 
JELTupleProvider - Class in hep.aida.ref.tuple
Serves as a Resolver and ValueProvider for JEL-based Evaluator and Filter
JELTupleProvider(ITuple) - Constructor for class hep.aida.ref.tuple.JELTupleProvider
 
jhplot - package jhplot
Main jHepWork numerical and graphical package
JHPlot - Class in jhplot
Show information about jHplot.
JHPlot() - Constructor for class jhplot.JHPlot
 
jhplot.bsom - package jhplot.bsom
Bayesian Self-Organizing Maps
jhplot.fit - package jhplot.fit
Predefined fit functions for the fit panel (HFit).
jhplot.io - package jhplot.io
jHPlot IO classes
jhplot.io.csv - package jhplot.io.csv
A very simple CSV parser for Java released under a commercial-friendly license.
jhplot.io.csv.bean - package jhplot.io.csv.bean
A simple bean binding interface for use with opencsv.
jhplot.io.sqlite - package jhplot.io.sqlite
SQLite3 database support
jhplot.jadraw - package jhplot.jadraw
Main JaPlot classes for plots and diagrams
jhplot.math - package jhplot.math
Math calculations and random numbers.
jhplot.math.io - package jhplot.math.io
IO package for math (based on jmathtools).
jhplot.math.num - package jhplot.math.num
Common classes used throughout numerics4j.
jhplot.math.num.integration - package jhplot.math.num.integration
Function interfaces.
jhplot.math.num.pdf - package jhplot.math.num.pdf
Statistical distributions.
jhplot.math.num.random - package jhplot.math.num.random
Random number generators and random variable generators.
jhplot.math.num.root - package jhplot.math.num.root
Function interfaces.
jhplot.math.num.special - package jhplot.math.num.special
Elementary functions not provided by the Java™.
jhplot.root - package jhplot.root
Access to ROOT files (based on Tony Johnson's RootHistogramBrowser).
jhplot.security - package jhplot.security
MD5 hash for objects or data files
jhplot.shapes - package jhplot.shapes
jHepWork package to draw java 2D primitives
jhplot.stat - package jhplot.stat
Statistical calculations: fluctuations, linear regression etc.
jhplot.v3d - package jhplot.v3d
Main jHepWork 3D geometry package.
JHPLOT_HTTP - Static variable in class jhplot.HelpBrowser
 
jhpro.stat - package jhpro.stat
 
jhpro.stat.limit - package jhpro.stat.limit
 
jhpro.test - package jhpro.test
 
JHreader - Class in jhplot.io
A class to read XML file and build jHPlot graphics.
JHreader() - Constructor for class jhplot.io.JHreader
 
JHwriter - Class in jhplot.io
A class to write graphics in XML file.
JHwriter() - Constructor for class jhplot.io.JHwriter
 
jminhep.cluster - package jminhep.cluster
jHepWork package for a cluster analysis.
jn(int, double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the first kind of order n of the argument.
jn(int, double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the Bessel function of the first kind of order n of the argument.
JNIMethods - Class in org.netlib.utils
Static helper methods for dealing with the Java Native Interface and detection of operating systems and architectures.
JNIMethods() - Constructor for class org.netlib.utils.JNIMethods
 
JNIMethods.ARCHType - Enum in org.netlib.utils
Enumeration of common CPU architectures.
JNIMethods.OSType - Enum in org.netlib.utils
Enumeration of common operating systems, independent of version or architecture.
JohnsonSBDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Johnson SB distribution with shape parameters γ and δ > 0, location parameter ξ, and scale parameter λ > 0.
JohnsonSBDist(double, double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Constructs a JohnsonSBDist object with shape parameters γ and δ, location parameter ξ and scale parameter λ.
JohnsonSBGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the Johnson SB distribution.
JohnsonSBGen(RandomStream, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.JohnsonSBGen
Creates a JohnsonSB random variate generator.
JohnsonSBGen(RandomStream, JohnsonSBDist) - Constructor for class umontreal.iro.lecuyer.randvar.JohnsonSBGen
Creates a new generator for the JohnsonSB distribution dist, using stream s.
JohnsonSUDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Johnson SU distribution.
JohnsonSUDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Same as JohnsonSUDist (gamma, delta, 0.0, 1.0).
JohnsonSUDist(double, double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Constructs a JohnsonSUDist object with shape parameters γ and δ, location parameter ξ, and scale parameter λ.
JohnsonSUGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the Johnson SU distribution.
JohnsonSUGen(RandomStream, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.JohnsonSUGen
Creates a JohnsonSU random variate generator.
JohnsonSUGen(RandomStream, JohnsonSUDist) - Constructor for class umontreal.iro.lecuyer.randvar.JohnsonSUGen
Creates a new generator for the JohnsonSU distribution dist, using stream s.
joule - Static variable in class cern.clhep.Units
 
jouleToCalorie(double) - Static method in class flanagan.math.Conv
 
jouleToCalorie(double) - Static method in class flanagan.math.Fmath
 

K

k - Variable in class cern.jet.stat.Buffer
 
k0(double) - Static method in class cern.jet.math.Bessel
Returns the modified Bessel function of the third kind of order 0 of the argument.
k0(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the modified Bessel function of the third kind of order 0 of the argument.
k0e(double) - Static method in class cern.jet.math.Bessel
Returns the exponentially scaled modified Bessel function of the third kind of order 0 of the argument.
k0e(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the exponentially scaled modified Bessel function of the third kind of order 0 of the argument.
k1(double) - Static method in class cern.jet.math.Bessel
Returns the modified Bessel function of the third kind of order 1 of the argument.
k1(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the modified Bessel function of the third kind of order 1 of the argument.
k1e(double) - Static method in class cern.jet.math.Bessel
Returns the exponentially scaled modified Bessel function of the third kind of order 1 of the argument.
k1e(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the exponentially scaled modified Bessel function of the third kind of order 1 of the argument.
k_Boltzmann - Static variable in class cern.clhep.PhysicalConstants
 
K_BOLTZMANN - Static variable in class flanagan.math.Fmath
 
kelvin - Static variable in class cern.clhep.Units
 
kelvinToCelsius(double) - Static method in class flanagan.math.Conv
 
kelvinToCelsius(double) - Static method in class flanagan.math.Fmath
 
KernelDensity - Class in umontreal.iro.lecuyer.gof
This class provides methods to compute a kernel density estimator from a set of n individual observations x0,…, xn-1, and returns its value at m selected points.
KernelDensity() - Constructor for class umontreal.iro.lecuyer.gof.KernelDensity
 
KernelDensityGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for distributions obtained via kernel density estimation methods from a set of n individual observations x1,..., xn.
KernelDensityGen(RandomStream, EmpiricalDist, RandomVariateGen, double) - Constructor for class umontreal.iro.lecuyer.randvar.KernelDensityGen
Creates a new generator for a kernel density estimated from the observations given by the empirical distribution dist, using stream s to select the observations, generator kGen to generate the added noise from the kernel density, and bandwidth h.
KernelDensityGen(RandomStream, EmpiricalDist, NormalGen) - Constructor for class umontreal.iro.lecuyer.randvar.KernelDensityGen
This constructor uses a gaussian kernel and the default bandwidth h = αkh0 with the αk suggested in Table  for the gaussian distribution.
KernelDensityVarCorrectGen - Class in umontreal.iro.lecuyer.randvar
This class is a variant of KernelDensityGen, but with a rescaling of the empirical distribution so that the variance of the density used to generate the random variates is equal to the empirical variance, as suggested by Silverman.
KernelDensityVarCorrectGen(RandomStream, EmpiricalDist, RandomVariateGen, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.KernelDensityVarCorrectGen
Creates a new generator for a kernel density estimated from the observations given by the empirical distribution dist, using stream s to select the observations, generator kGen to generate the added noise from the kernel density, bandwidth h, and σk2 = sigmak2 used for the variance correction.
KernelDensityVarCorrectGen(RandomStream, EmpiricalDist, NormalGen) - Constructor for class umontreal.iro.lecuyer.randvar.KernelDensityVarCorrectGen
This constructor uses a gaussian kernel and the default bandwidth suggested in Table  for the gaussian distribution.
keV - Static variable in class cern.clhep.Units
 
key(int) - Method in class hep.aida.ref.Annotation
Get the key corresponding to the item in a given position in the Annotation.
Key - Static variable in class jhplot.HPlotJa
 
Key(int, String, float, float) - Static method in class jhplot.jadraw.Diagram
Get a text with key symbol
key() - Method in class org.apache.commons.math.util.OpenIntToDoubleHashMap.Iterator
Get the key of current entry.
key() - Method in class org.apache.commons.math.util.OpenIntToFieldHashMap.Iterator
Get the key of current entry.
keyOf(int) - Method in class cern.colt.map.AbstractDoubleIntMap
Returns the first key the given value is associated with.
keyOf(double) - Method in class cern.colt.map.AbstractIntDoubleMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.AbstractIntIntMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.AbstractIntObjectMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.AbstractLongObjectMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.OpenDoubleIntHashMap
Returns the first key the given value is associated with.
keyOf(double) - Method in class cern.colt.map.OpenIntDoubleHashMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.OpenIntIntHashMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.OpenIntObjectHashMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.OpenLongObjectHashMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Returns the first key the given value is associated with.
keyOf(long) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Returns the first key the given value is associated with.
keyOf(double) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Returns the first key the given value is associated with.
keyOf(double) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Returns the first key the given value is associated with.
keyOf(long) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Returns the first key the given value is associated with.
keyOf(double) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Returns the first key the given value is associated with.
keyOf(double) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Returns the first key the given value is associated with.
keyOf(long) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Returns the first key the given value is associated with.
keyOf(float) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Returns the first key the given value is associated with.
keyOf(float) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Returns the first key the given value is associated with.
keyOf(long) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Returns the first key the given value is associated with.
keyOf(float) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Returns the first key the given value is associated with.
keyOf(float) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.tint.AbstractIntIntMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Returns the first key the given value is associated with.
keyOf(long) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Returns the first key the given value is associated with.
keyOf(long) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Returns the first key the given value is associated with.
keyOf(long) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Returns the first key the given value is associated with.
keyOf(int) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Returns the first key the given value is associated with.
keyOf(long) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Returns the first key the given value is associated with.
keyOf(Object) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Returns the first key the given value is associated with.
keys() - Method in class cern.colt.map.AbstractDoubleIntMap
Returns a list filled with all keys contained in the receiver.
keys(DoubleArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.AbstractIntDoubleMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.AbstractIntIntMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.AbstractIntObjectMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.AbstractLongObjectMap
Returns a list filled with all keys contained in the receiver.
keys(LongArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all keys contained in the receiver into the specified list.
keys(DoubleArrayList) - Method in class cern.colt.map.OpenDoubleIntHashMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.OpenIntDoubleHashMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.OpenIntIntHashMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.OpenIntObjectHashMap
Fills all keys contained in the receiver into the specified list.
keys(LongArrayList) - Method in class cern.colt.map.OpenLongObjectHashMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Returns a list filled with all keys contained in the receiver.
keys(DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Returns a list filled with all keys contained in the receiver.
keys(DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Returns a list filled with all keys contained in the receiver.
keys(LongArrayList) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Fills all keys contained in the receiver into the specified list.
keys(DoubleArrayList) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Fills all keys contained in the receiver into the specified list.
keys(DoubleArrayList) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Fills all keys contained in the receiver into the specified list.
keys(LongArrayList) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Returns a list filled with all keys contained in the receiver.
keys(FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Returns a list filled with all keys contained in the receiver.
keys(FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Returns a list filled with all keys contained in the receiver.
keys(LongArrayList) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Fills all keys contained in the receiver into the specified list.
keys(FloatArrayList) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Fills all keys contained in the receiver into the specified list.
keys(FloatArrayList) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Fills all keys contained in the receiver into the specified list.
keys(LongArrayList) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tint.AbstractIntIntMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.tint.AbstractIntIntMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tlong.AbstractIntLongMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tlong.AbstractLongIntMap
Returns a list filled with all keys contained in the receiver.
keys(LongArrayList) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tlong.AbstractLongLongMap
Returns a list filled with all keys contained in the receiver.
keys(LongArrayList) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Fills all keys contained in the receiver into the specified list.
keys(LongArrayList) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Fills all keys contained in the receiver into the specified list.
keys(LongArrayList) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Returns a list filled with all keys contained in the receiver.
keys(IntArrayList) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Fills all keys contained in the receiver into the specified list.
keys() - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Returns a list filled with all keys contained in the receiver.
keys(LongArrayList) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Fills all keys contained in the receiver into the specified list.
keys(IntArrayList) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Fills all keys contained in the receiver into the specified list.
keys(LongArrayList) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Fills all keys contained in the receiver into the specified list.
keysSortedByValue(DoubleArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(LongArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(LongArrayList) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(LongArrayList) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.tint.AbstractIntIntMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(LongArrayList) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(LongArrayList) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(IntArrayList) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Fills all keys sorted ascending by their associated value into the specified list.
keysSortedByValue(LongArrayList) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Fills all keys sorted ascending by their associated value into the specified list.
kg - Static variable in class cern.clhep.Units
 
kGasThreshold - Static variable in class cern.clhep.PhysicalConstants
 
kgToPound(double) - Static method in class flanagan.math.Conv
 
kgToPound(double) - Static method in class flanagan.math.Fmath
 
kgToTon(double) - Static method in class flanagan.math.Conv
 
kgToTon(double) - Static method in class flanagan.math.Fmath
 
kill(SimProcess) - Method in class umontreal.iro.lecuyer.simprocs.DSOLProcessSimulator
 
kill(SimProcess) - Method in class umontreal.iro.lecuyer.simprocs.ProcessSimulator
Terminates the life of process and sets its state to DEAD, after canceling its control event if there is one.
kill() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Terminates the life of this process and sets its state to DEAD, after canceling its activating event if there is one.
kill(SimProcess) - Method in class umontreal.iro.lecuyer.simprocs.ThreadProcessSimulator
 
killAll() - Method in class umontreal.iro.lecuyer.simprocs.DSOLProcessSimulator
 
killAll() - Method in class umontreal.iro.lecuyer.simprocs.ProcessSimulator
Kills all currently living (active, delayed, or suspended) processes managed by this simulator.
killAll() - Method in class umontreal.iro.lecuyer.simprocs.ThreadProcessSimulator
Kills all threads linked to the current variable.
kiloelectronvolt - Static variable in class cern.clhep.Units
 
kilogauss - Static variable in class cern.clhep.Units
 
kilogram - Static variable in class cern.clhep.Units
 
kilohertz - Static variable in class cern.clhep.Units
 
kilometer - Static variable in class cern.clhep.Units
 
kilometer2 - Static variable in class cern.clhep.Units
 
kilometer3 - Static variable in class cern.clhep.Units
 
kilovolt - Static variable in class cern.clhep.Units
 
km - Static variable in class cern.clhep.Units
 
km2 - Static variable in class cern.clhep.Units
 
km3 - Static variable in class cern.clhep.Units
 
KMeansPlusPlusClusterer<T extends Clusterable<T>> - Class in org.apache.commons.math.stat.clustering
Clustering algorithm based on David Arthur and Sergei Vassilvitski k-means++ algorithm.
KMeansPlusPlusClusterer(Random) - Constructor for class org.apache.commons.math.stat.clustering.KMeansPlusPlusClusterer
Build a clusterer.
KMeansPlusPlusClusterer(Random, KMeansPlusPlusClusterer.EmptyClusterStrategy) - Constructor for class org.apache.commons.math.stat.clustering.KMeansPlusPlusClusterer
Build a clusterer.
KMeansPlusPlusClusterer.EmptyClusterStrategy - Enum in org.apache.commons.math.stat.clustering
Strategies to use for replacing an empty cluster.
kmPerLitreToMilePerGallon(double) - Static method in class flanagan.math.Conv
 
kmPerLitreToMilePerGallon(double) - Static method in class flanagan.math.Fmath
 
kmToMile(double) - Static method in class flanagan.math.Conv
 
kmToMile(double) - Static method in class flanagan.math.Fmath
 
kn(int, double) - Static method in class cern.jet.math.Bessel
Returns the modified Bessel function of the third kind of order nn of the argument.
kn(int, double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the modified Bessel function of the third kind of order nn of the argument.
known_N_compute_B_and_K(long, double, double, int, double[]) - Static method in class cern.jet.stat.quantile.QuantileFinderFactory
Computes the number of buffers and number of values per buffer such that quantiles can be determined with an approximation error no more than epsilon with a certain probability.
known_N_compute_B_and_K(long, double, double, int, double[]) - Static method in class cern.jet.stat.tdouble.quantile.DoubleQuantileFinderFactory
Computes the number of buffers and number of values per buffer such that quantiles can be determined with an approximation error no more than epsilon with a certain probability.
known_N_compute_B_and_K(long, float, float, int, float[]) - Static method in class cern.jet.stat.tfloat.quantile.FloatQuantileFinderFactory
Computes the number of buffers and number of values per buffer such that quantiles can be determined with an approximation error no more than epsilon with a certain probability.
kolmogorovSmirnov(DoubleArrayList) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Computes the Kolmogorov-Smirnov (KS) test statistics DN+, DN-, and DN.
KolmogorovSmirnovDist - Class in jhplot.math
This class computes both the cumulative probability P[D_n <= x] and the complementary cumulative probability P[D_n >= x] of the 2-sided 1-sample Kolmogorov-Smirnov distribution.
KolmogorovSmirnovDist() - Constructor for class jhplot.math.KolmogorovSmirnovDist
 
KolmogorovSmirnovDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Kolmogorov-Smirnov distribution with parameter n.
KolmogorovSmirnovDist(int) - Constructor for class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
Constructs a distribution with parameter n.
KolmogorovSmirnovDistQuick - Class in umontreal.iro.lecuyer.probdist
Extends the class KolmogorovSmirnovDist for the distribution.
KolmogorovSmirnovDistQuick(int) - Constructor for class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDistQuick
Constructs a distribution with parameter n.
kolmogorovSmirnovJumpOne(DoubleArrayList, double) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Compute the KS statistics DN+(a) and DN-(a) defined in the description of the method FDist.kolmogorovSmirnovPlusJumpOne, assuming that F is the uniform distribution over [0, 1] and that U(1),..., U(N) are in sortedData.
KolmogorovSmirnovPlusDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Kolmogorov-Smirnov+ distribution (see).
KolmogorovSmirnovPlusDist(int) - Constructor for class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
Constructs an Kolmogorov-Smirnov+ distribution for a sample of size n.
kolmogorovSmirnovPlusJumpOne(int, double, double) - Static method in class umontreal.iro.lecuyer.gof.FDist
Similar to KolmogorovSmirnovPlusDist but for the case where the distribution function F has a jump of size a at a given point x0, is zero at the left of x0, and is continuous at the right of x0.
KorobovLattice - Class in umontreal.iro.lecuyer.hups
This class implements Korobov lattices, which are the same point sets as in class LCGPointSet, but implemented differently.
KorobovLattice(int, int, int) - Constructor for class umontreal.iro.lecuyer.hups.KorobovLattice
Instantiates a Korobov lattice point set with modulus n and multiplier a in dimension s.
KorobovLattice(int, int, int, int) - Constructor for class umontreal.iro.lecuyer.hups.KorobovLattice
Instantiates a shifted Korobov lattice point set with modulus n and multiplier a in dimension s.
KorobovLatticeSequence - Class in umontreal.iro.lecuyer.hups
This class implements Korobov lattice sequences, defined as follows.
KorobovLatticeSequence(int, int) - Constructor for class umontreal.iro.lecuyer.hups.KorobovLatticeSequence
Constructs a new lattice sequence with base b and generator = a.
kron(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Computes the Kronecker product of two real matrices.
kron(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Computes the Kronecker product of two real matrices.
kron(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Computes the Kronecker product of two real matrices.
kron(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Computes the Kronecker product of two real matrices.
KS - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Kolmogorov-Smirnov test
KSM - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Kolmogorov-Smirnov- test
KSP - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Kolmogorov-Smirnov+ test
kurtosis() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the kurtosis (aka excess), which is -3 + moment(4,mean()) / standardDeviation()4.
kurtosis(double, double) - Static method in class cern.jet.stat.Descriptive
Returns the kurtosis (aka excess) of a data sequence.
kurtosis(DoubleArrayList, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the kurtosis (aka excess) of a data sequence, which is -3 + moment(data,4,mean) / standardDeviation4.
kurtosis(double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the kurtosis (aka excess) of a data sequence.
kurtosis(DoubleArrayList, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the kurtosis (aka excess) of a data sequence, which is -3 + moment(data,4,mean) / standardDeviation4.
kurtosis(float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the kurtosis (aka excess) of a data sequence.
kurtosis(FloatArrayList, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the kurtosis (aka excess) of a data sequence, which is -3 + moment(data,4,mean) / standardDeviation4.
kurtosis() - Method in class flanagan.analysis.Stat
 
kurtosis(double[]) - Static method in class flanagan.analysis.Stat
 
kurtosis(float[]) - Static method in class flanagan.analysis.Stat
 
kurtosis(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
kurtosis(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
kurtosis(long[]) - Static method in class flanagan.analysis.Stat
 
kurtosis(int[]) - Static method in class flanagan.analysis.Stat
 
kurtosis() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the kurtosis (aka excess), which is -3 + moment(4,mean()) / standardDeviation()4.
kurtosis() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the kurtosis (aka excess), which is -3 + moment(4,mean()) / standardDeviation()4.
kurtosis() - Method in class jhplot.P0D
Returns the kurtosis.
kurtosis() - Method in class jhplot.P0I
Returns the kurtosis.
Kurtosis - Class in org.apache.commons.math.stat.descriptive.moment
Computes the Kurtosis of the available values.
Kurtosis() - Constructor for class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Construct a Kurtosis
Kurtosis(FourthMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Construct a Kurtosis from an external moment
Kurtosis(Kurtosis) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Kurtosis
Copy constructor, creates a new Kurtosis identical to the original
kurtosis_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
kurtosis_as_double() - Method in class flanagan.analysis.Stat
 
kurtosisExcess() - Method in class flanagan.analysis.Stat
 
kurtosisExcess(double[]) - Static method in class flanagan.analysis.Stat
 
kurtosisExcess(float[]) - Static method in class flanagan.analysis.Stat
 
kurtosisExcess(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
kurtosisExcess(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
kurtosisExcess(long[]) - Static method in class flanagan.analysis.Stat
 
kurtosisExcess(int[]) - Static method in class flanagan.analysis.Stat
 
kurtosisExcess_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
kurtosisExcess_as_double() - Method in class flanagan.analysis.Stat
 

L

LabelX - Static variable in class jhplot.HPlotJa
 
LabelY - Static variable in class jhplot.HPlotJa
 
lag1(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the lag-1 autocorrelation of a dataset; Note that this method has semantics different from autoCorrelation(..., 1);
lag1(DoubleArrayList, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the lag-1 autocorrelation of a dataset; Note that this method has semantics different from autoCorrelation(..., 1);
lag1(FloatArrayList, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the lag-1 autocorrelation of a dataset; Note that this method has semantics different from autoCorrelation(..., 1);
LaguerreSolver - Class in org.apache.commons.math.analysis.solvers
Implements the Laguerre's Method for root finding of real coefficient polynomials.
LaguerreSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.solvers.LaguerreSolver
Deprecated. as of 2.0 the function to solve is passed as an argument to the LaguerreSolver.solve(UnivariateRealFunction, double, double) or UnivariateRealSolver.solve(UnivariateRealFunction, double, double, double) method.
LaguerreSolver() - Constructor for class org.apache.commons.math.analysis.solvers.LaguerreSolver
Deprecated. in 2.2 (to be removed in 3.0)
lambdaOne() - Method in class flanagan.analysis.BoxCox
 
lambdaTwo() - Method in class flanagan.analysis.BoxCox
 
Landau - Class in jhplot.fit
The function represents the Landau distribution.
Landau() - Constructor for class jhplot.fit.Landau
 
Landau(String) - Constructor for class jhplot.fit.Landau
 
Landau(String[], String[]) - Constructor for class jhplot.fit.Landau
 
LAPACK - Class in org.netlib.lapack
LAPACK provider which will attempt to access a native implementation and falling back to use F2J if none is available.
LAPACK() - Constructor for class org.netlib.lapack.LAPACK
 
Laplace - Class in jhplot.math.num.pdf
The Laplace distribution.
Laplace() - Constructor for class jhplot.math.num.pdf.Laplace
Default constructor.
Laplace(double, double) - Constructor for class jhplot.math.num.pdf.Laplace
Create a distribution with the given mean and scale.
LaplaceDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Laplace distribution.
LaplaceDist() - Constructor for class umontreal.iro.lecuyer.probdist.LaplaceDist
Constructs a LaplaceDist object with default parameters μ = 0 and β = 1.
LaplaceDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.LaplaceDist
Constructs a LaplaceDist object with parameters μ = mu and β = beta.
LaplaceRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Laplace distribution.
LaplaceRandomVariable() - Constructor for class jhplot.math.num.random.LaplaceRandomVariable
Default constructor.
LaplaceRandomVariable(double, double) - Constructor for class jhplot.math.num.random.LaplaceRandomVariable
Create a random variable with the given mean and scale.
LaplaceRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.LaplaceRandomVariable
Create a random variable with the given parameters.
largestPrime - Static variable in class cern.colt.map.PrimeFinder
The largest prime this class can generate; currently equal to Integer.MAX_VALUE.
lastIndexOf(boolean) - Method in class cern.colt.list.AbstractBooleanList
Returns the index of the last occurrence of the specified element.
lastIndexOf(byte) - Method in class cern.colt.list.AbstractByteList
Returns the index of the last occurrence of the specified element.
lastIndexOf(char) - Method in class cern.colt.list.AbstractCharList
Returns the index of the last occurrence of the specified element.
lastIndexOf(double) - Method in class cern.colt.list.AbstractDoubleList
Returns the index of the last occurrence of the specified element.
lastIndexOf(float) - Method in class cern.colt.list.AbstractFloatList
Returns the index of the last occurrence of the specified element.
lastIndexOf(int) - Method in class cern.colt.list.AbstractIntList
Returns the index of the last occurrence of the specified element.
lastIndexOf(long) - Method in class cern.colt.list.AbstractLongList
Returns the index of the last occurrence of the specified element.
lastIndexOf(short) - Method in class cern.colt.list.AbstractShortList
Returns the index of the last occurrence of the specified element.
lastIndexOf(Object, boolean) - Method in class cern.colt.list.ObjectArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOf(boolean) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns the index of the last occurrence of the specified element.
lastIndexOf(byte) - Method in class cern.colt.list.tbyte.AbstractByteList
Returns the index of the last occurrence of the specified element.
lastIndexOf(char) - Method in class cern.colt.list.tchar.AbstractCharList
Returns the index of the last occurrence of the specified element.
lastIndexOf(double) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns the index of the last occurrence of the specified element.
lastIndexOf(float) - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns the index of the last occurrence of the specified element.
lastIndexOf(int) - Method in class cern.colt.list.tint.AbstractIntList
Returns the index of the last occurrence of the specified element.
lastIndexOf(long) - Method in class cern.colt.list.tlong.AbstractLongList
Returns the index of the last occurrence of the specified element.
lastIndexOf(Object, boolean) - Method in class cern.colt.list.tobject.ObjectArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOf(short) - Method in class cern.colt.list.tshort.AbstractShortList
Returns the index of the last occurrence of the specified element.
lastIndexOf(Object) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
lastIndexOfFromTo(boolean, int, int) - Method in class cern.colt.list.AbstractBooleanList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(byte, int, int) - Method in class cern.colt.list.AbstractByteList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(char, int, int) - Method in class cern.colt.list.AbstractCharList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(double, int, int) - Method in class cern.colt.list.AbstractDoubleList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(float, int, int) - Method in class cern.colt.list.AbstractFloatList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(int, int, int) - Method in class cern.colt.list.AbstractIntList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(long, int, int) - Method in class cern.colt.list.AbstractLongList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(short, int, int) - Method in class cern.colt.list.AbstractShortList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(boolean, int, int) - Method in class cern.colt.list.BooleanArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(byte, int, int) - Method in class cern.colt.list.ByteArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(char, int, int) - Method in class cern.colt.list.CharArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(double, int, int) - Method in class cern.colt.list.DoubleArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(float, int, int) - Method in class cern.colt.list.FloatArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(int, int, int) - Method in class cern.colt.list.IntArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(long, int, int) - Method in class cern.colt.list.LongArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(Object, int, int, boolean) - Method in class cern.colt.list.ObjectArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(short, int, int) - Method in class cern.colt.list.ShortArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(boolean, int, int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(boolean, int, int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(byte, int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(byte, int, int) - Method in class cern.colt.list.tbyte.ByteArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(char, int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(char, int, int) - Method in class cern.colt.list.tchar.CharArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(double, int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(double, int, int) - Method in class cern.colt.list.tdouble.DoubleArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(float, int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(float, int, int) - Method in class cern.colt.list.tfloat.FloatArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(int, int, int) - Method in class cern.colt.list.tint.AbstractIntList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(int, int, int) - Method in class cern.colt.list.tint.IntArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(long, int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(long, int, int) - Method in class cern.colt.list.tlong.LongArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(Object, int, int, boolean) - Method in class cern.colt.list.tobject.ObjectArrayList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(short, int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Returns the index of the last occurrence of the specified element.
lastIndexOfFromTo(short, int, int) - Method in class cern.colt.list.tshort.ShortArrayList
Returns the index of the last occurrence of the specified element.
lastPowerOfTwo(int) - Static method in class flanagan.math.FourierTransform
 
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaAxes
The LaTeX command that is necessary to draw the given JaAxes using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaBlob
The LaTeX command that is necessary to draw the given JaBlob using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaBox
The LaTeX command that is necessary to draw the given Label using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaFArc
The LaTeX command that is necessary to draw this JaFArc using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaFLine
The LaTeX command that is necessary to draw this JaFLine using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaFLoop
The LaTeX command that is necessary to draw this JaFLoop using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaGArc
The LaTeX command that is necessary to draw this JaGArc using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaGlArc
The LaTeX command that is necessary to draw this JaGlArc using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaGLine
The LaTeX command that is necessary to draw this JaGLine using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaGlLine
The LaTeX command that is necessary to draw this JaGlLine using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaGlLoop
The LaTeX command that is necessary to draw this JaGlLoop using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaGLoop
The LaTeX command that is necessary to draw this JaGLoop using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaKey
The LaTeX command that is necessary to draw the given label using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaLatexText
The LaTeX command that is necessary to draw the given JaxoText using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaLine
The LaTeX command that is necessary to draw this JaFLine using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaObject
The LaTeX command that is necessary to draw the given JaObject using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaPArc
The LaTeX command that is necessary to draw this JaPArc using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaPLine
The LaTeX command that is necessary to draw this JaPLine using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaPLoop
The LaTeX command that is necessary to draw this JaPLoop using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaSArc
The LaTeX command that is necessary to draw this JaSArc using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaSLine
The LaTeX command that is necessary to draw this JaSLine using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaSLoop
The LaTeX command that is necessary to draw this JaSLoop using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaText
The LaTeX command that is necessary to draw the given label using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaTextBox
The LaTeX command that is necessary to draw the given Label using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaVertex
The LaTeX command that is necessary to draw the given JaObject using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaVertexT1
The LaTeX command that is necessary to draw the given JaVertexT1 using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaVertexT2
The LaTeX command that is necessary to draw the given JaVertexT2 using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaVertexT3
The LaTeX command that is necessary to draw the given JaVertexT3 using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaVertexT4
The LaTeX command that is necessary to draw the given JaVertexT4 using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaVertexT5
The LaTeX command that is necessary to draw the given JaVertexT2 using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaVertexT6
The LaTeX command that is necessary to draw the given JaVertexT6 using the axodraw.sty package.
latexCommand(float, Dimension) - Method in class jhplot.jadraw.JaZigZagLine
The LaTeX command that is necessary to draw this JaZigZagLine using the axodraw.sty package.
latexWidth() - Method in class jhplot.jadraw.JaArcObject
The LaTeX command that sets the width for this Arc, using the axodraw.sty package.
latexWidth() - Method in class jhplot.jadraw.JaFillObject
Returns the string that sets the latex line width of this FillObject.
latexWidth() - Method in class jhplot.jadraw.JaKey
Returns the line width of this label.
latexWidth() - Method in class jhplot.jadraw.JaLatexText
Returns the line width of this JaxoText.
latexWidth() - Method in class jhplot.jadraw.JaLineObject
The LaTeX command that sets the width for this Line, using the axodraw.sty package.
latexWidth() - Method in class jhplot.jadraw.JaLoopObject
The LaTeX command that sets the width for this Loop, using the axodraw.sty package.
latexWidth() - Method in class jhplot.jadraw.JaObject
The LaTeX command that sets the width for this JaObject, using the axodraw.sty package.
latexWidth() - Method in class jhplot.jadraw.JaText
Returns the line width of this label.
latexWidth() - Method in class jhplot.jadraw.JaVertex
Returns the line width of this JaVertex.
LCGPointSet - Class in umontreal.iro.lecuyer.hups
Implements a recurrence-based point set defined via a linear congruential recurrence of the form xi = axi-1mod n and ui = xi/n.
LCGPointSet(int, int) - Constructor for class umontreal.iro.lecuyer.hups.LCGPointSet
Constructs and stores the set of cycles for an LCG with modulus n and multiplier a.
LCGPointSet(int, int, int, int) - Constructor for class umontreal.iro.lecuyer.hups.LCGPointSet
Constructs and stores the set of cycles for an LCG with modulus n = be + c and multiplier a.
lcm(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Returns the least common multiple of the absolute value of two numbers, using the formula lcm(a,b) = (a / gcd(a,b)) * b.
lcm(long, long) - Static method in class org.apache.commons.math.util.MathUtils
Returns the least common multiple of the absolute value of two numbers, using the formula lcm(a,b) = (a / gcd(a,b)) * b.
leapFrog(double[], F1D, double) - Static method in class jhplot.math.Numeric
Uses the Leap-Frog method to solve an ODE.
leapYear(int) - Static method in class flanagan.math.Fmath
 
leapYear(int) - Method in class flanagan.math.TimeAndDate
 
learn() - Method in class jhplot.bsom.BsomDemo
Set learn mode
leastSignificantBit(int) - Static method in class cern.colt.bitvector.QuickBitVector
Returns the index of the least significant bit in state "true".
leastSignificantBit(int) - Static method in class cern.colt.matrix.tbit.QuickBitVector
Returns the index of the least significant bit in state "true".
LeastSquares - Class in umontreal.iro.lecuyer.functionfit
Represents a polynomial obtained by the least squares method on a set of points.
LeastSquares(double[], double[], int) - Constructor for class umontreal.iro.lecuyer.functionfit.LeastSquares
Constructs a new least squares polynomial with points (x[0], y[0]),..., (x[n], y[n]).
LeastSquaresConverter - Class in org.apache.commons.math.optimization
This class converts vectorial objective functions to scalar objective functions when the goal is to minimize them.
LeastSquaresConverter(MultivariateVectorialFunction, double[]) - Constructor for class org.apache.commons.math.optimization.LeastSquaresConverter
Build a simple converter for uncorrelated residuals with the same weight.
LeastSquaresConverter(MultivariateVectorialFunction, double[], double[]) - Constructor for class org.apache.commons.math.optimization.LeastSquaresConverter
Build a simple converter for uncorrelated residuals with the specific weights.
LeastSquaresConverter(MultivariateVectorialFunction, double[], RealMatrix) - Constructor for class org.apache.commons.math.optimization.LeastSquaresConverter
Build a simple converter for correlated residuals with the specific weights.
LeastSquaresFitMethod - Class in hep.aida.ref.fitter.fitmethod
 
LeastSquaresFitMethod() - Constructor for class hep.aida.ref.fitter.fitmethod.LeastSquaresFitMethod
 
LEDataInputStream - Class in jhplot.math.io
This class was designed on the base of Roedy Green LEDataInputStream Thanks to Roedy Green, Canadian Mind Products mailto:roedy@mindprod.com http://mindprod.com
LEDataInputStream(InputStream) - Constructor for class jhplot.math.io.LEDataInputStream
 
LEDataOutputStream - Class in jhplot.math.io
This class was designed on the base of Roedy Green LEDataInputStream Thanks to Roedy Green, Canadian Mind Products mailto:roedy@mindprod.com http://mindprod.com
LEDataOutputStream(OutputStream) - Constructor for class jhplot.math.io.LEDataOutputStream
 
LEFT - Static variable in class cern.colt.matrix.AbstractFormatter
The alignment string aligning the cells of a column to the left.
LEFT - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The alignment string aligning the cells of a column to the left.
leftMatrixScramble(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Applies a linear scramble by multiplying each Cj on the left by a w×w nonsingular lower-triangular matrix Mj, as suggested by Matoušek and implemented by Hong and Hickernell.
leftMatrixScramble(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
leftMatrixScrambleDiag(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Similar to leftMatrixScramble except that all the off-diagonal elements of the Mj are 0.
leftMatrixScrambleDiag(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
leftMatrixScrambleFaurePermut(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Similar to leftMatrixScramble except that the diagonal elements of each matrix Mj are chosen from a restricted set of the best integers as calculated by Faure.
leftMatrixScrambleFaurePermut(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
leftMatrixScrambleFaurePermutAll(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Similar to leftMatrixScrambleFaurePermut except that the elements under the diagonal are also chosen from the same restricted set as the diagonal elements.
leftMatrixScrambleFaurePermutAll(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
leftMatrixScrambleFaurePermutDiag(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Similar to leftMatrixScrambleFaurePermut except that all off-diagonal elements are 0.
leftMatrixScrambleFaurePermutDiag(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
LegendreGaussIntegrator - Class in org.apache.commons.math.analysis.integration
Implements the Legendre-Gauss quadrature formula.
LegendreGaussIntegrator(int, int) - Constructor for class org.apache.commons.math.analysis.integration.LegendreGaussIntegrator
Build a Legendre-Gauss integrator.
length() - Method in class flanagan.math.ArrayMaths
 
length() - Method in class hep.aida.ref.function.RangeSet
 
LENGTH - Static variable in class jhplot.jadraw.JaObject
An integer that gives the length of the handle sides.
length() - Method in class jhplot.math.io.LERandomAccessFile
 
length() - Method in class umontreal.iro.lecuyer.util.PrintfFormat
 
LERandomAccessFile - Class in jhplot.math.io
This class was designed on the base of Roedy Green LEDataInputStream Thanks to Roedy Green, Canadian Mind Products mailto:roedy@mindprod.com http://mindprod.com
LERandomAccessFile(String, String) - Constructor for class jhplot.math.io.LERandomAccessFile
constructors
LERandomAccessFile(File, String) - Constructor for class jhplot.math.io.LERandomAccessFile
 
less(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A[row,col] = A[row,col] < s ? 1 : 0.
less(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A[row,col] = A[row,col] < B[row,col] ? 1 : 0.
less - Static variable in class cern.jet.math.Functions
Function that returns a < b ? 1 : 0.
less(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a < b ? 1 : 0.
less - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a < b ? 1 : 0.
less(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a < b ? 1 : 0.
less - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a < b ? 1 : 0.
less(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a < b ? 1 : 0.
lessThan(Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Check if instance is less than x.
letterToNumeral() - Method in class flanagan.analysis.Scores
 
level - Variable in class cern.jet.stat.Buffer
 
level() - Method in class cern.jet.stat.Buffer
Returns whether the receiver's level.
level(int) - Method in class cern.jet.stat.Buffer
Sets the receiver's level.
LevenbergMarquardtEstimator - Class in org.apache.commons.math.estimation
Deprecated. as of 2.0, everything in package org.apache.commons.math.estimation has been deprecated and replaced by package org.apache.commons.math.optimization.general
LevenbergMarquardtEstimator() - Constructor for class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Deprecated. Build an estimator for least squares problems.
LevenbergMarquardtOptimizer - Class in org.apache.commons.math.optimization.general
This class solves a least squares problem using the Levenberg-Marquardt algorithm.
LevenbergMarquardtOptimizer() - Constructor for class org.apache.commons.math.optimization.general.LevenbergMarquardtOptimizer
Build an optimizer for least squares problems.
LFSR113 - Class in umontreal.iro.lecuyer.rng
Extends RandomStreamBase using a composite linear feedback shift register (LFSR) (or Tausworthe) RNG as defined in.
LFSR113() - Constructor for class umontreal.iro.lecuyer.rng.LFSR113
Constructs a new stream.
LFSR113(String) - Constructor for class umontreal.iro.lecuyer.rng.LFSR113
Constructs a new stream with the identifier name.
LFSR258 - Class in umontreal.iro.lecuyer.rng
Extends RandomStreamBase using a 64-bit composite linear feedback shift register (LFSR) (or Tausworthe) RNG as defined in.
LFSR258() - Constructor for class umontreal.iro.lecuyer.rng.LFSR258
Constructs a new stream.
LFSR258(String) - Constructor for class umontreal.iro.lecuyer.rng.LFSR258
Constructs a new stream with the identifier name.
lg - Static variable in class cern.jet.math.Functions
Function that returns Math.log(a) / Math.log(b).
lg(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns Math.log(a) / Math.log(b).
lg - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.log(a) / Math.log(b).
lg(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns Math.log(a) / Math.log(b) .
lg - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.log(a) / Math.log(b).
lg(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns Math.log(a) / Math.log(b) .
like() - Method in class cern.colt.matrix.DoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.DoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.DoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.DoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.DoubleMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int, int) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like() - Method in class cern.colt.matrix.ObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.ObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.ObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.ObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.ObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
like(int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCMDComplexMatrix2D
 
like(int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCMDComplexMatrix2D
 
like(int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
like() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
like(int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseCCMDoubleMatrix2D
 
like(int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseRCMDoubleMatrix2D
 
like(int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
like() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
like(int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCMFComplexMatrix2D
 
like(int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCMFComplexMatrix2D
 
like(int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
like() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
like(int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseCCMFloatMatrix2D
 
like(int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseRCMFloatMatrix2D
 
like(int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
like(int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tint.impl.DenseLargeIntMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseLargeIntMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tint.impl.SparseCCMIntMatrix2D
 
like(int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tint.impl.SparseRCMIntMatrix2D
 
like(int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
like() - Method in class cern.colt.matrix.tint.IntMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.tint.IntMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.tint.IntMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix3D
 
like(int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
like(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseCCMLongMatrix2D
 
like(int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
like(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseRCMLongMatrix2D
 
like(int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
like() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix3D
 
like(int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int, int) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseCCMObjectMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
like(int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseRCMObjectMatrix2D
 
like(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
like(int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like(int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
like(int, int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
like() - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same size.
like(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified size.
like() - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of rows and columns.
like(int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of rows and columns.
like() - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the same number of slices, rows and columns.
like(int, int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Construct and returns a new empty matrix of the same dynamic type as the receiver, having the specified number of slices, rows and columns.
like1D(int) - Method in class cern.colt.matrix.DoubleMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.ObjectMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tint.impl.DenseLargeIntMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like1D(int) - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
like1D(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Construct and returns a new 1-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.DoubleMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.ObjectMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirely independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Construct and returns a new 2-d matrix of the corresponding dynamic type, sharing the same cells.
like2D(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Construct and returns a new 2-d matrix of the corresponding dynamic type, sharing the same cells.
like2D(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirely independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Construct and returns a new 2-d matrix of the corresponding dynamic type, sharing the same cells.
like2D(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Construct and returns a new 2-d matrix of the corresponding dynamic type, sharing the same cells.
like2D(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Construct and returns a new 2-d matrix of the corresponding dynamic type, sharing the same cells.
like2D(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
like2D(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Construct and returns a new 2-d matrix of the corresponding dynamic type, sharing the same cells.
like2D(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
like2D(int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Construct and returns a new 2-d matrix of the corresponding dynamic type, entirelly independent of the receiver.
like2D(int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Construct and returns a new 2-d matrix of the corresponding dynamic type, sharing the same cells.
LimitCalculator - Class in jhpro.stat.limit
Create a limit calculator.
LimitCalculator() - Constructor for class jhpro.stat.limit.LimitCalculator
 
LimitCalculatorGui - Class in jhpro.stat.limit
 
LimitCalculatorGui() - Constructor for class jhpro.stat.limit.LimitCalculatorGui
 
LimitCalculatorGui.ExperimentData - Class in jhpro.stat.limit
 
LimitCalculatorGui.myFrame - Class in jhpro.stat.limit
 
LINE - Static variable in class jhplot.shapes.HShape
 
Line - Class in jhplot.shapes
Draw a line in the user or NDC coordinate system
Line(double, double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.Line
Main constructor fot a line
Line(double, double, double, double) - Constructor for class jhplot.shapes.Line
Make a line using black (default) color and default stroke
LINE_SEPARATOR - Static variable in class umontreal.iro.lecuyer.util.PrintfFormat
Deprecated. 
linear() - Method in class flanagan.analysis.Regression
 
LINEAR_INTERPOLATION - Static variable in class cern.jet.random.Empirical
 
LINEAR_INTERPOLATION - Static variable in class cern.jet.random.tdouble.Empirical
 
LinearAlgebra - Class in jhplot.math
A collection of static methods for performing math operations on matrices and arrays.
LinearAlgebra() - Constructor for class jhplot.math.LinearAlgebra
 
LinearCongruentialRNG - Class in jhplot.math.num.random
A general linear congruential generator.
LinearCongruentialRNG(long, long) - Constructor for class jhplot.math.num.random.LinearCongruentialRNG
Create a linear congruential generator with the given modulus and multiplier.
LinearCongruentialRNG(long, long, long) - Constructor for class jhplot.math.num.random.LinearCongruentialRNG
Create a linear congruential generator with the given parameters.
LinearCongruentialRNG(long, long, long, long) - Constructor for class jhplot.math.num.random.LinearCongruentialRNG
Create a linear congruential generator with the given parameters.
LinearConstraint - Class in org.apache.commons.math.optimization.linear
A linear constraint for a linear optimization problem.
LinearConstraint(double[], Relationship, double) - Constructor for class org.apache.commons.math.optimization.linear.LinearConstraint
Build a constraint involving a single linear equation.
LinearConstraint(RealVector, Relationship, double) - Constructor for class org.apache.commons.math.optimization.linear.LinearConstraint
Build a constraint involving a single linear equation.
LinearConstraint(double[], double, Relationship, double[], double) - Constructor for class org.apache.commons.math.optimization.linear.LinearConstraint
Build a constraint involving two linear equations.
LinearConstraint(RealVector, double, Relationship, RealVector, double) - Constructor for class org.apache.commons.math.optimization.linear.LinearConstraint
Build a constraint involving two linear equations.
linearConv(double, double, Matrix) - Method in class jhplot.bsom.Matrix
Linear conversion: a*X + b*Y.
linearCorrCoeff(double, int) - Static method in class flanagan.analysis.Stat
 
linearCorrCoeffProb(double, int) - Static method in class flanagan.analysis.Stat
 
linearGeneral() - Method in class flanagan.analysis.Regression
 
linearGeneralPlot(String, String) - Method in class flanagan.analysis.Regression
 
linearGeneralPlot() - Method in class flanagan.analysis.Regression
 
LinearInterpolator - Class in org.apache.commons.math.analysis.interpolation
Implements a linear function for interpolation of real univariate functions.
LinearInterpolator() - Constructor for class org.apache.commons.math.analysis.interpolation.LinearInterpolator
 
LinearObjectiveFunction - Class in org.apache.commons.math.optimization.linear
An objective function for a linear optimization problem.
LinearObjectiveFunction(double[], double) - Constructor for class org.apache.commons.math.optimization.linear.LinearObjectiveFunction
 
LinearObjectiveFunction(RealVector, double) - Constructor for class org.apache.commons.math.optimization.linear.LinearObjectiveFunction
 
LinearOptimizer - Interface in org.apache.commons.math.optimization.linear
This interface represents an optimization algorithm for linear problems.
linearPlot(String, String) - Method in class flanagan.analysis.Regression
 
linearPlot() - Method in class flanagan.analysis.Regression
 
Link - Class in hep.aida.ref.tree
A Link is a managed object representing a symbolic link.
LINK_ADDED - Static variable in class hep.aida.ref.event.TreeEvent
 
LinkedListStat<E> - Class in umontreal.iro.lecuyer.simevents
This class extends ListWithStat, and uses a linked list as the internal data structure.
LinkedListStat() - Constructor for class umontreal.iro.lecuyer.simevents.LinkedListStat
Constructs a new list, initially empty.
LinkedListStat(Simulator) - Constructor for class umontreal.iro.lecuyer.simevents.LinkedListStat
Constructs a new list, initially empty, and using the default simulator.
LinkedListStat(Collection<? extends E>) - Constructor for class umontreal.iro.lecuyer.simevents.LinkedListStat
Constructs a list containing the elements of the specified collection, using the default simulator.
LinkedListStat(Simulator, Collection<? extends E>) - Constructor for class umontreal.iro.lecuyer.simevents.LinkedListStat
Constructs a list containing the elements of the specified collection.
LinkedListStat(String) - Constructor for class umontreal.iro.lecuyer.simevents.LinkedListStat
Constructs a new list with name name, using the default simulator.
LinkedListStat(Simulator, String) - Constructor for class umontreal.iro.lecuyer.simevents.LinkedListStat
Constructs a new list with name name.
LinkedListStat(Collection<? extends E>, String) - Constructor for class umontreal.iro.lecuyer.simevents.LinkedListStat
Constructs a new list containing the elements of the specified collection c and with name name, using the default simulator.
LinkedListStat(Simulator, Collection<? extends E>, String) - Constructor for class umontreal.iro.lecuyer.simevents.LinkedListStat
Constructs a new list containing the elements of the specified collection c and with name name.
LinReg - Class in jhplot.stat
A linear regression analysis.
LinReg(double[], double[]) - Constructor for class jhplot.stat.LinReg
Constructor for regression calculations
LinReg(P1D) - Constructor for class jhplot.stat.LinReg
constructor for regression calculations.
LinRegWeighted - Class in jhplot.stat
Weighted Least Squares Regression
LinRegWeighted(double[], double[], double[]) - Constructor for class jhplot.stat.LinRegWeighted
Constructor for regression calculations
list() - Method in class hep.aida.ref.function.FunctionCatalog
 
listAll() - Method in class jhplot.HBook
List all objects inside HBook
listDir(String) - Static method in class umontreal.iro.lecuyer.hups.DigitalNetBase2FromFile
Lists all files (or directories) in directory dirname.
listDir(String) - Static method in class umontreal.iro.lecuyer.hups.DigitalNetFromFile
Lists all files (or directories) in directory dirname.
listDirHTML(String, String) - Static method in class umontreal.iro.lecuyer.hups.DigitalNetFromFile
Creates a list of all data files in directory dirname and writes that list in format HTML in output file filename.
listEntries() - Method in class jhplot.io.PFile
List objects stored in the file.
listH1D() - Method in class jhplot.HBook
List all known H1D histograms.
listH2D() - Method in class jhplot.HBook
List all known H1D histograms.
listIterator() - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
listIterator() - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
listIterator() - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Returns a list iterator over the elements of the class Event in this list.
listIterator() - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
listIterator() - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
listIterator() - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
listIterator() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
 
listIterator(int) - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
 
listIterator() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
listIterator(int) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
listIterator() - Method in class umontreal.iro.lecuyer.util.TransformingList
 
listIterator(int) - Method in class umontreal.iro.lecuyer.util.TransformingList
 
listObjectNames() - Method in class hep.aida.ref.tree.Tree
Get the list of names of the IManagedObjects under a given path, including directories (but not "." and "..").
listObjectNames(String) - Method in class hep.aida.ref.tree.Tree
Get the list of names of the IManagedObjects under a given path, including directories (but not "." and "..").
listObjectNames(String, boolean) - Method in class hep.aida.ref.tree.Tree
Get the list of names of the IManagedObjects under a given path, including directories (but not "." and "..").
listObjectNames() - Method in class jhplot.io.FileAida
List name of the objects inside trees
listObjectTypes() - Method in class hep.aida.ref.tree.Tree
Get the list of types of the IManagedObjects under a given path.
listObjectTypes(String) - Method in class hep.aida.ref.tree.Tree
Get the list of types of the IManagedObjects under a given path.
listObjectTypes(String, boolean) - Method in class hep.aida.ref.tree.Tree
Get the list of types of the IManagedObjects under a given path.
ListOfStatProbes<E extends StatProbe> - Class in umontreal.iro.lecuyer.stat.list
Represents a list of statistical probes that can be managed simultaneously.
ListOfStatProbes() - Constructor for class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Constructs an empty list of statistical probes.
ListOfStatProbes(String) - Constructor for class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Constructs an empty list of statistical probes with name name.
ListOfTallies<E extends Tally> - Class in umontreal.iro.lecuyer.stat.list
Represents a list of tally statistical collectors.
ListOfTallies() - Constructor for class umontreal.iro.lecuyer.stat.list.ListOfTallies
Constructs a new empty list of tallies.
ListOfTallies(String) - Constructor for class umontreal.iro.lecuyer.stat.list.ListOfTallies
Constructs a new empty list of tallies with name name.
ListOfTalliesWithCovariance<E extends Tally> - Class in umontreal.iro.lecuyer.stat.list
Extends ListOfTallies to add support for the computation of the sample covariance between each pair of elements in a list, without storing all observations.
ListOfTalliesWithCovariance() - Constructor for class umontreal.iro.lecuyer.stat.list.ListOfTalliesWithCovariance
Creates an empty list of tallies with covariance support.
ListOfTalliesWithCovariance(String) - Constructor for class umontreal.iro.lecuyer.stat.list.ListOfTalliesWithCovariance
Creates an empty list of tallies with covariance support and name name.
listP1D() - Method in class jhplot.HBook
List all known P1D objects.
listParameterSettings() - Method in class hep.aida.ref.fitter.Fitter
 
ListPopulation - Class in org.apache.commons.math.genetics
Population of chromosomes represented by a List.
ListPopulation(List<Chromosome>, int) - Constructor for class org.apache.commons.math.genetics.ListPopulation
Creates a new ListPopulation instance.
ListPopulation(int) - Constructor for class org.apache.commons.math.genetics.ListPopulation
Creates a new ListPopulation instance and initializes its inner chromosome list.
ListWithStat<E> - Class in umontreal.iro.lecuyer.simevents
Implements a list with integrated statistical probes to provide automatic collection of statistics on the sojourn times of objects in the list and on the size of the list as a function of time given by a simulator.
ListWithStat(List<ListWithStat.Node<E>>) - Constructor for class umontreal.iro.lecuyer.simevents.ListWithStat
Constructs a new list with internal data structure using the default simulator and implemented by nodeList.
ListWithStat(Simulator, List<ListWithStat.Node<E>>) - Constructor for class umontreal.iro.lecuyer.simevents.ListWithStat
Constructs a new list with internal data structure implemented by nodeList.
ListWithStat(List<ListWithStat.Node<E>>, Collection<? extends E>) - Constructor for class umontreal.iro.lecuyer.simevents.ListWithStat
Constructs a list containing the elements of the specified collection, whose elements are stored into nodeList and using the default simulator.
ListWithStat(Simulator, List<ListWithStat.Node<E>>, Collection<? extends E>) - Constructor for class umontreal.iro.lecuyer.simevents.ListWithStat
Constructs a list containing the elements of the specified collection, whose elements are stored into nodeList.
ListWithStat(List<ListWithStat.Node<E>>, String) - Constructor for class umontreal.iro.lecuyer.simevents.ListWithStat
Constructs a new list with name name, internal list nodeList, and using the default simulator.
ListWithStat(Simulator, List<ListWithStat.Node<E>>, String) - Constructor for class umontreal.iro.lecuyer.simevents.ListWithStat
Constructs a new list with name name, and internal list nodeList.
ListWithStat(List<ListWithStat.Node<E>>, Collection<? extends E>, String) - Constructor for class umontreal.iro.lecuyer.simevents.ListWithStat
Constructs a new list containing the elements of the specified collection c, with name name, internal list nodeList, and using the default simulator.
ListWithStat(Simulator, List<ListWithStat.Node<E>>, Collection<? extends E>, String) - Constructor for class umontreal.iro.lecuyer.simevents.ListWithStat
Constructs a new list containing the elements of the specified collection c, with name name, and internal list nodeList.
ListWithStat.Node<E> - Class in umontreal.iro.lecuyer.simevents
Represents a node that can be part of a list with statistical collecting.
ListWithStat.Node(E, double) - Constructor for class umontreal.iro.lecuyer.simevents.ListWithStat.Node
Constructs a new node containing element element inserted into the list at time insertionTime.
litrePerKmToGallonPerMile(double) - Static method in class flanagan.math.Conv
 
litrePerKmToGallonPerMile(double) - Static method in class flanagan.math.Fmath
 
litreToGallon(double) - Static method in class flanagan.math.Conv
 
litreToGallon(double) - Static method in class flanagan.math.Fmath
 
litreToPint(double) - Static method in class flanagan.math.Conv
 
litreToPint(double) - Static method in class flanagan.math.Fmath
 
litreToQuart(double) - Static method in class flanagan.math.Conv
 
litreToQuart(double) - Static method in class flanagan.math.Fmath
 
LITTLE_ENDIAN - Static variable in class jhplot.math.io.BinaryFile
 
LITTLE_ENDIAN - Static variable in class jhplot.math.io.BinaryInputStream
 
LITTLE_ENDIAN - Static variable in class jhplot.math.io.BinaryOutputStream
 
LMScrambleShift - Class in umontreal.iro.lecuyer.hups
This class implements a PointSetRandomization that performs a left matrix scrambling and adds a random digital shift.
LMScrambleShift() - Constructor for class umontreal.iro.lecuyer.hups.LMScrambleShift
Empty constructor.
LMScrambleShift(RandomStream) - Constructor for class umontreal.iro.lecuyer.hups.LMScrambleShift
Sets internal variable stream to the given stream.
LN2 - Static variable in class umontreal.iro.lecuyer.util.Num
The values of ln 2.
LN_DBL_MIN - Static variable in class umontreal.iro.lecuyer.util.Num
Natural logarithm of DBL_MIN.
lnBeta(double, double) - Static method in class umontreal.iro.lecuyer.util.Num
Computes the natural logarithm of the Beta function B(λ, ν).
lnElements(double[]) - Static method in class flanagan.math.Fmath
 
lnElements(float[]) - Static method in class flanagan.math.Fmath
 
lnFactorial(int) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of the natural logarithm of factorial n.
lnGamma(double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the natural logarithm of the gamma function Γ(x) evaluated at x.
load(String) - Method in class jhplot.BRoot
Load a ROOT file
load(H1D, String) - Method in class jhplot.HFit
Load a histogram for a fit
load(P1D, String) - Method in class jhplot.HFit
Load data for a fit
load(String, boolean) - Method in class jhplot.io.FileAida
Load a AIDA file
load(double[]) - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Computes the empirical distribution from the provided array of numbers.
load(File) - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Computes the empirical distribution from the input file.
load(URL) - Method in interface org.apache.commons.math.random.EmpiricalDistribution
Computes the empirical distribution using data read from a URL.
load(double[]) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Computes the empirical distribution from the provided array of numbers.
load(URL) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Computes the empirical distribution using data read from a URL.
load(File) - Method in class org.apache.commons.math.random.EmpiricalDistributionImpl
Computes the empirical distribution from the input file.
loadAll(String) - Method in class hep.aida.ref.function.FunctionCatalog
 
loadData(P1D) - Method in class jhplot.bsom.Bsom
 
loadData(String) - Method in class jhplot.bsom.Bsom
 
loadingFactorsAsColumns() - Method in class flanagan.analysis.PCA
 
loadingFactorsAsRows() - Method in class flanagan.analysis.PCA
 
loc - Variable in class umontreal.iro.lecuyer.gof.GofStat.OutcomeCategoriesChi2
loc[i] gives the relocation of the category i in the nbExp array.
Localizable - Interface in org.apache.commons.math.exception.util
Interface for localizable strings.
LocalizedFormats - Enum in org.apache.commons.math.exception.util
Enumeration for localized messages formats used in exceptions messages.
LoessInterpolator - Class in org.apache.commons.math.analysis.interpolation
Implements the Local Regression Algorithm (also Loess, Lowess) for interpolation of real univariate functions.
LoessInterpolator() - Constructor for class org.apache.commons.math.analysis.interpolation.LoessInterpolator
Constructs a new LoessInterpolator with a bandwidth of LoessInterpolator.DEFAULT_BANDWIDTH, LoessInterpolator.DEFAULT_ROBUSTNESS_ITERS robustness iterations and an accuracy of {#link #DEFAULT_ACCURACY}.
LoessInterpolator(double, int) - Constructor for class org.apache.commons.math.analysis.interpolation.LoessInterpolator
Constructs a new LoessInterpolator with given bandwidth and number of robustness iterations.
LoessInterpolator(double, int, double) - Constructor for class org.apache.commons.math.analysis.interpolation.LoessInterpolator
Constructs a new LoessInterpolator with given bandwidth, number of robustness iterations and accuracy.
log(double, double) - Static method in class cern.jet.math.Arithmetic
Returns logbasevalue.
log - Static variable in class cern.jet.math.Functions
Function that returns Math.log(a).
log(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
log - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
log(double, double) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Returns logbasevalue.
log - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.log(a).
log(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
log - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
log(float, float) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Returns logbasevalue.
log - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.log(a).
log(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
log() - Method in class flanagan.analysis.Stat
 
log() - Method in class flanagan.math.ArrayMaths
 
log(double) - Static method in class flanagan.math.Fmath
 
log(float) - Static method in class flanagan.math.Fmath
 
log() - Method in class jhplot.math.Complex
Principal branch of the Complex logarithm of this Complex number.
log(ValueErr) - Static method in class jhplot.math.ValueErr
Take natural log
LOG - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.log method wrapped as a ComposableFunction.
log() - Method in class org.apache.commons.math.complex.Complex
Compute the natural logarithm of this complex number.
log(Dfp) - Static method in class org.apache.commons.math.dfp.DfpMath
Returns the natural logarithm of a.
log(double) - Static method in class org.apache.commons.math.util.FastMath
Natural logarithm.
log(double, double) - Static method in class org.apache.commons.math.util.MathUtils
Returns the logarithm for base b of x.
log10(double) - Static method in class cern.jet.math.Arithmetic
Returns log10value.
log10(double) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Returns log10value.
log10(float) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Returns log10value.
log10(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
log10() - Method in class flanagan.analysis.Stat
 
log10() - Method in class flanagan.math.ArrayMaths
 
log10(double) - Static method in class flanagan.math.Fmath
 
log10(float) - Static method in class flanagan.math.Fmath
 
log10(double, double) - Static method in class flanagan.math.Fmath
 
log10(double, int) - Static method in class flanagan.math.Fmath
 
log10(float, float) - Static method in class flanagan.math.Fmath
 
log10(float, int) - Static method in class flanagan.math.Fmath
 
log10(ValueErr) - Static method in class jhplot.math.ValueErr
log to base 10
LOG10 - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.log10 method wrapped as a ComposableFunction.
log10() - Method in class org.apache.commons.math.dfp.Dfp
Get the exponent of the greatest power of 10 that is less than or equal to abs(this).
log10(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the base 10 logarithm.
log10Elements(double[]) - Static method in class flanagan.math.Fmath
 
log10Elements(float[]) - Static method in class flanagan.math.Fmath
 
log10K() - Method in class org.apache.commons.math.dfp.Dfp
Get the exponent of the greatest power of 10000 that is less than or equal to the absolute value of this.
LOG1P - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.log1p method wrapped as a ComposableFunction.
log1p(double) - Static method in class org.apache.commons.math.util.FastMath
Compute log(1 + x).
log2(double) - Static method in class cern.jet.math.Arithmetic
Returns log2value.
log2 - Static variable in class cern.jet.math.Functions
Function that returns Math.log(a) / Math.log(2).
log2(double) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Returns log2value.
log2 - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.log(a) / Math.log(2).
log2(float) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Returns log2value.
log2 - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.log(a) / Math.log(2).
log2() - Method in class flanagan.analysis.Stat
 
log2() - Method in class flanagan.math.ArrayMaths
 
log2(double) - Static method in class flanagan.math.Fmath
 
log2(float) - Static method in class flanagan.math.Fmath
 
log2(double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns log2(x).
LOG_2_PI - Static variable in interface jhplot.math.num.Constants
log(2 π).
Logarithmic - Class in cern.jet.random
Logarithmic distribution.
Logarithmic(double, RandomEngine) - Constructor for class cern.jet.random.Logarithmic
Constructs a Logarithmic distribution.
Logarithmic - Class in cern.jet.random.tdouble
Logarithmic distribution.
Logarithmic(double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.Logarithmic
Constructs a Logarithmic distribution.
LogarithmicDist - Class in umontreal.iro.lecuyer.probdist
Extends the class DiscreteDistributionInt for the logarithmic distribution.
LogarithmicDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.LogarithmicDist
Constructs a logarithmic distribution with parameter θ = theta.
LogarithmicGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the (discrete) logarithmic distribution.
LogarithmicGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.LogarithmicGen
Creates a logarithmic random variate generator with parameters θ = theta and default value θ0 = 0.96, using stream s.
LogarithmicGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.LogarithmicGen
Creates a logarithmic random variate generator with parameters θ = theta and θ0 = theta0, using stream s.
LogarithmicGen(RandomStream, LogarithmicDist) - Constructor for class umontreal.iro.lecuyer.randvar.LogarithmicGen
Creates a new generator with distribution dist and stream s, with default value θ0 = 0.96.
LogarithmicGen(RandomStream, LogarithmicDist, double) - Constructor for class umontreal.iro.lecuyer.randvar.LogarithmicGen
Creates a new generator with distribution dist and stream s, with θ0 = theta0.
logBeta(double, double) - Static method in class jhplot.math.num.special.Beta
Returns the natural logarithm of the beta function B(a, b) (1).
logBeta(double, double) - Static method in class org.apache.commons.math.special.Beta
Returns the natural logarithm of the beta function B(a, b).
logBeta(double, double, double, int) - Static method in class org.apache.commons.math.special.Beta
Returns the natural logarithm of the beta function B(a, b).
logBinomialProbability(int, int, double, double) - Static method in class jhplot.math.num.pdf.SaddlePoint
Compute the PMF for a binomial distribution using the saddle point expansion.
logDeterminant() - Method in class flanagan.math.Matrix
 
logDeterminant(Matrix) - Static method in class flanagan.math.Matrix
 
logDeterminant(double[][]) - Static method in class flanagan.math.Matrix
 
logEC50() - Method in class flanagan.analysis.Regression
 
logEC50constrained() - Method in class flanagan.analysis.Regression
 
logEC50constrainedPlot() - Method in class flanagan.analysis.Regression
 
logEC50Plot() - Method in class flanagan.analysis.Regression
 
logFactorial(int) - Static method in class cern.jet.math.Arithmetic
Returns log(k!).
logFactorial(int) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Returns log(k!).
logFactorial(int) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Returns log(k!).
logFactorial(int) - Static method in class flanagan.analysis.Stat
 
logFactorial(long) - Static method in class flanagan.analysis.Stat
 
logFactorial(double) - Static method in class flanagan.analysis.Stat
 
logFactorial(int) - Static method in class flanagan.math.Fmath
 
logFactorial(long) - Static method in class flanagan.math.Fmath
 
logFactorial(double) - Static method in class flanagan.math.Fmath
 
logGamma(double) - Static method in class cern.jet.random.PoissonSlow
Returns the value ln(Gamma(xx) for xx > 0.
logGamma(double) - Static method in class cern.jet.random.tdouble.PoissonSlow
Returns the value ln(Gamma(xx) for xx > 0.
logGamma(double) - Static method in class cern.jet.stat.Gamma
Returns the natural logarithm of the gamma function; formerly named lgamma.
logGamma(double) - Static method in class cern.jet.stat.tdouble.Gamma
Returns the natural logarithm of the gamma function; formerly named lgamma.
logGamma(double) - Static method in class flanagan.analysis.Stat
 
logGamma(double) - Static method in class jhplot.math.num.special.Gamma
Returns the natural logarithm of the gamma function Γ(x) (1).
logGamma(double) - Static method in class org.apache.commons.math.special.Gamma
Returns the natural logarithm of the gamma function Γ(x).
logGammaFunction(double) - Static method in class flanagan.analysis.Stat
 
logistic() - Method in class flanagan.analysis.Regression
 
logistic(double, double, double) - Static method in class flanagan.analysis.Stat
 
Logistic - Class in jhplot.math.num.pdf
The Logistic distribution.
Logistic() - Constructor for class jhplot.math.num.pdf.Logistic
Default constructor.
Logistic(double, double) - Constructor for class jhplot.math.num.pdf.Logistic
Create a distribution with the given mean and scale parameters.
logisticArray(double, double, int) - Method in class flanagan.math.PsRandom
 
logisticBeta() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticBetaError() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logisticCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
logisticCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
LogisticDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the logistic distribution.
LogisticDist() - Constructor for class umontreal.iro.lecuyer.probdist.LogisticDist
Constructs a LogisticDist object with default parameters α = 0 and λ = 1.
LogisticDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.LogisticDist
Constructs a LogisticDist object with parameters α = alpha and λ = lambda.
LogisticGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the logistic distribution.
LogisticGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.LogisticGen
Creates a logistic random variate generator with parameters α = alpha and λ = lambda, using stream s.
LogisticGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.LogisticGen
Creates a logistic random variate generator with parameters α = 0 and λ = 1, using stream s.
LogisticGen(RandomStream, LogisticDist) - Constructor for class umontreal.iro.lecuyer.randvar.LogisticGen
Creates a new generator for the logistic distribution dist and stream s.
logisticGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logisticMean(double) - Static method in class flanagan.analysis.Stat
 
logisticMedian(double) - Static method in class flanagan.analysis.Stat
 
logisticMode(double) - Static method in class flanagan.analysis.Stat
 
logisticMu() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticMuError() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
logisticPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logisticPlot() - Method in class flanagan.analysis.Regression
 
logisticProb(double, double, double) - Static method in class flanagan.analysis.Stat
 
logisticProb(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
logisticProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
logisticRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
LogisticRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Logistic distribution.
LogisticRandomVariable() - Constructor for class jhplot.math.num.random.LogisticRandomVariable
Default constructor.
LogisticRandomVariable(double, double) - Constructor for class jhplot.math.num.random.LogisticRandomVariable
Create a random variable with the given mean and scale.
LogisticRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.LogisticRandomVariable
Create a random variable with the given parameters.
logisticStandardDeviation(double) - Static method in class flanagan.analysis.Stat
 
logisticStandDev(double) - Static method in class flanagan.analysis.Stat
 
logisticSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
logisticTwoParCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logisticTwoParCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
logisticTwoParInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logisticTwoParMean(double) - Static method in class flanagan.analysis.Stat
 
logisticTwoParMedian(double) - Static method in class flanagan.analysis.Stat
 
logisticTwoParMode(double) - Static method in class flanagan.analysis.Stat
 
logisticTwoParOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
logisticTwoParPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logisticTwoParRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
logisticTwoParRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
logisticTwoParStandardDeviation(double) - Static method in class flanagan.analysis.Stat
 
LoglogisticDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Log-Logistic distribution with shape parameter α > 0 and scale parameter β > 0.
LoglogisticDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.LoglogisticDist
Constructs a log-logistic distribution with parameters α and β.
LoglogisticGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the log-logistic distribution with shape parameter α > 0 and scale parameter β > 0.
LoglogisticGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.LoglogisticGen
Creates a log-logistic random variate generator with parameters α = alpha and β = beta, using stream s.
LoglogisticGen(RandomStream, LoglogisticDist) - Constructor for class umontreal.iro.lecuyer.randvar.LoglogisticGen
Creates a new generator for the distribution dist, using stream s.
logNormal() - Method in class flanagan.analysis.Regression
 
LogNormal - Class in jhplot.math.num.pdf
The Log Normal distribution.
LogNormal() - Constructor for class jhplot.math.num.pdf.LogNormal
Default constructor.
LogNormal(double, double) - Constructor for class jhplot.math.num.pdf.LogNormal
Create a distribution with the given mean and standard deviation.
logNormal(double, double) - Static method in class jhplot.math.Random
Generate a random number from a LogNormal random variable.
logNormalArray(double, double, int) - Method in class flanagan.math.PsRandom
 
logNormalCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
LognormalDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the lognormal distribution.
LognormalDist() - Constructor for class umontreal.iro.lecuyer.probdist.LognormalDist
Constructs a LognormalDist object with default parameters μ = 0 and σ = 1.
LognormalDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.LognormalDist
Constructs a LognormalDist object with parameters μ = mu and σ = sigma.
LognormalDistFromMoments - Class in umontreal.iro.lecuyer.probdist
Extends the LognormalDist class with a constructor accepting the mean m and the variance v of the distribution as arguments.
LognormalDistFromMoments(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.LognormalDistFromMoments
 
LognormalGen - Class in umontreal.iro.lecuyer.randvar
This class implements methods for generating random variates from the lognormal distribution.
LognormalGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.LognormalGen
Creates a lognormal random variate generator with parameters μ = mu and σ = sigma, using stream s.
LognormalGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.LognormalGen
Creates a lognormal random variate generator with parameters μ = 0 and σ = 1, using stream s.
LognormalGen(RandomStream, LognormalDist) - Constructor for class umontreal.iro.lecuyer.randvar.LognormalGen
Create a random variate generator for the lognormal distribution dist and stream s.
logNormalInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalInverseCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalMean(double, double) - Static method in class flanagan.analysis.Stat
 
logNormalMedian(double) - Static method in class flanagan.analysis.Stat
 
logNormalMode(double, double) - Static method in class flanagan.analysis.Stat
 
logNormalOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
logNormalOrderStatisticMedians(double, double, double, int) - Static method in class flanagan.analysis.Stat
 
logNormalPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalPlot() - Method in class flanagan.analysis.Regression
 
logNormalRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
logNormalRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
LogNormalRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Log Normal distribution.
LogNormalRandomVariable() - Constructor for class jhplot.math.num.random.LogNormalRandomVariable
Default constructor.
LogNormalRandomVariable(double, double) - Constructor for class jhplot.math.num.random.LogNormalRandomVariable
Create a random variable with the given mean and standard deviation.
LogNormalRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.LogNormalRandomVariable
Create a random variable with the given parameters.
LognormalSpecialGen - Class in umontreal.iro.lecuyer.randvar
Implements methods for generating random variates from the lognormal distribution using an arbitrary normal random variate generator.
LognormalSpecialGen(NormalGen) - Constructor for class umontreal.iro.lecuyer.randvar.LognormalSpecialGen
Create a lognormal random variate generator using the normal generator g and with the same parameters.
logNormalStandardDeviation(double, double) - Static method in class flanagan.analysis.Stat
 
logNormalStandDev(double, double) - Static method in class flanagan.analysis.Stat
 
logNormalThreePar() - Method in class flanagan.analysis.Regression
 
logNormalThreeParArray(double, double, double, int) - Method in class flanagan.math.PsRandom
 
logNormalThreeParCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalThreeParCDF(double, double, double, double, double) - Static method in class flanagan.analysis.Stat
 
LogNormalThreeParFunct - Class in flanagan.analysis
 
LogNormalThreeParFunct() - Constructor for class flanagan.analysis.LogNormalThreeParFunct
 
logNormalThreeParInverseCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalThreeParMean(double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalThreeParMedian(double, double) - Static method in class flanagan.analysis.Stat
 
logNormalThreeParMode(double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalThreeParOrderStatisticMedians(double, double, double, int) - Static method in class flanagan.analysis.Stat
 
logNormalThreeParPDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalThreeParPlot() - Method in class flanagan.analysis.Regression
 
logNormalThreeParRand(double, double, double, int) - Static method in class flanagan.analysis.Stat
 
logNormalThreeParRand(double, double, double, int, long) - Static method in class flanagan.analysis.Stat
 
logNormalThreeParStandardDeviation(double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalThreeParStandDev(double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalTwoPar() - Method in class flanagan.analysis.Regression
 
logNormalTwoParArray(double, double, int) - Method in class flanagan.math.PsRandom
 
logNormalTwoParCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalTwoParCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormaltwoParInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalTwoParMean(double, double) - Static method in class flanagan.analysis.Stat
 
logNormalTwoParMedian(double) - Static method in class flanagan.analysis.Stat
 
logNormalTwoParMode(double, double) - Static method in class flanagan.analysis.Stat
 
logNormalTwoParOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
logNormalTwoParPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
logNormalTwoParPlot() - Method in class flanagan.analysis.Regression
 
logNormalTwoParRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
logNormalTwoParRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
logNormalTwoParStandardDeviation(double, double) - Static method in class flanagan.analysis.Stat
 
logNormalTwoParStandDev(double, double) - Static method in class flanagan.analysis.Stat
 
LongArrayList - Class in cern.colt.list
Resizable list holding long elements; implemented with arrays.
LongArrayList() - Constructor for class cern.colt.list.LongArrayList
Constructs an empty list.
LongArrayList(long[]) - Constructor for class cern.colt.list.LongArrayList
Constructs a list containing the specified elements.
LongArrayList(int) - Constructor for class cern.colt.list.LongArrayList
Constructs an empty list with the specified initial capacity.
LongArrayList - Class in cern.colt.list.tlong
Resizable list holding long elements; implemented with arrays.
LongArrayList() - Constructor for class cern.colt.list.tlong.LongArrayList
Constructs an empty list.
LongArrayList(long[]) - Constructor for class cern.colt.list.tlong.LongArrayList
Constructs a list containing the specified elements.
LongArrayList(int) - Constructor for class cern.colt.list.tlong.LongArrayList
Constructs an empty list with the specified initial capacity.
LongBuffer - Class in cern.colt.buffer.tlong
Fixed sized (non resizable) streaming buffer connected to a target LongBufferConsumer to which data is automatically flushed upon buffer overflow.
LongBuffer(LongBufferConsumer, int) - Constructor for class cern.colt.buffer.tlong.LongBuffer
Constructs and returns a new buffer with the given target.
LongBuffer2D - Class in cern.colt.buffer.tlong
Fixed sized (non resizable) streaming buffer connected to a target LongBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
LongBuffer2D(LongBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.tlong.LongBuffer2D
Constructs and returns a new buffer with the given target.
LongBuffer2DConsumer - Interface in cern.colt.buffer.tlong
Target of a streaming LongBuffer2D into which data is flushed upon buffer overflow.
LongBuffer3D - Class in cern.colt.buffer.tlong
Fixed sized (non resizable) streaming buffer connected to a target LongBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
LongBuffer3D(LongBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.tlong.LongBuffer3D
Constructs and returns a new buffer with the given target.
LongBuffer3DConsumer - Interface in cern.colt.buffer.tlong
Target of a streaming LongBuffer3D into which data is flushed upon buffer overflow.
LongBufferConsumer - Interface in cern.colt.buffer.tlong
Target of a streaming LongBuffer into which data is flushed upon buffer overflow.
LongComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
LongComparator - Interface in cern.colt.function.tlong
A comparison function which imposes a total ordering on some collection of elements.
LongDoubleProcedure - Interface in cern.colt.function.tdouble
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
longFactorial(int) - Static method in class cern.jet.math.Arithmetic
Instantly returns the factorial k!.
longFactorial(int) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Instantly returns the factorial k!.
longFactorial(int) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Instantly returns the factorial k!.
LongFactory1D - Class in cern.colt.matrix.tlong
Factory for convenient construction of 1-d matrices holding int cells.
LongFactory2D - Class in cern.colt.matrix.tlong
Factory for convenient construction of 2-d matrices holding int cells.
LongFactory3D - Class in cern.colt.matrix.tlong
Factory for convenient construction of 3-d matrices holding int cells.
LongFloatProcedure - Interface in cern.colt.function.tfloat
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
LongFormatter - Class in cern.colt.matrix.tlong.algo
Flexible, well human readable matrix print formatting; By default decimal point aligned.
LongFormatter() - Constructor for class cern.colt.matrix.tlong.algo.LongFormatter
Constructs and returns a matrix formatter with format "%G".
LongFormatter(String) - Constructor for class cern.colt.matrix.tlong.algo.LongFormatter
Constructs and returns a matrix formatter.
LongFunction - Interface in cern.colt.function.tlong
Interface that represents a function object: a function that takes a single argument and returns a single value.
LongFunctions - Class in cern.jet.math.tlong
Long Function objects to be passed to generic methods.
longFunctions - Static variable in class cern.jet.math.tlong.LongFunctions
Little trick to allow for "aliasing", that is, renaming this class.
LongIntProcedure - Interface in cern.colt.function.tlong
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
LongListAdapter - Class in cern.colt.list.adapter
Adapter that permits an AbstractLongList to be viewed and treated as a JDK 1.2 AbstractList.
LongListAdapter(AbstractLongList) - Constructor for class cern.colt.list.adapter.LongListAdapter
Constructs a list backed by the specified content list.
LongListAdapter - Class in cern.colt.list.tlong
Adapter that permits an AbstractLongList to be viewed and treated as a JDK 1.2 AbstractList.
LongListAdapter(AbstractLongList) - Constructor for class cern.colt.list.tlong.LongListAdapter
Constructs a list backed by the specified content list.
LongLongFunction - Interface in cern.colt.function.tlong
Interface that represents a function object: a function that takes two arguments and returns a single value.
LongLongLongProcedure - Interface in cern.colt.function.tlong
Interface that represents a procedure object: a procedure that takes three arguments and does not return a value.
LongLongProcedure - Interface in cern.colt.function.tlong
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
LongMatrix1D - Class in cern.colt.matrix.tlong
Abstract base class for 1-d matrices (aka vectors) holding int elements.
LongMatrix1DComparator - Interface in cern.colt.matrix.tlong.algo
A comparison function which imposes a total ordering on some collection of elements.
LongMatrix1DProcedure - Interface in cern.colt.matrix.tlong
Longerface that represents a condition or procedure object: takes a single argument and returns a boolean value.
LongMatrix2D - Class in cern.colt.matrix.tlong
Abstract base class for 2-d matrices holding int elements.
LongMatrix2DComparator - Interface in cern.colt.matrix.tlong.algo
A comparison function which imposes a total ordering on some collection of elements.
LongMatrix2DProcedure - Interface in cern.colt.matrix.tlong
Longerface that represents a condition or procedure object: takes a single argument and returns a boolean value.
LongMatrix3D - Class in cern.colt.matrix.tlong
Abstract base class for 3-d matrices holding int elements.
LongMatrix3DProcedure - Interface in cern.colt.matrix.tlong
Longerface that represents a condition or procedure object: takes a single argument and returns a boolean value.
LongMult - Class in cern.jet.math.tlong
Only for performance tuning of compute longensive linear algebraic computations.
LongObjectProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
LongObjectProcedure - Interface in cern.colt.function.tobject
Interface that represents a procedure object: a procedure that takes two arguments and does not return a value.
LongPlusMultFirst - Class in cern.jet.math.tlong
Only for performance tuning of compute longensive linear algebraic computations.
LongPlusMultSecond - Class in cern.jet.math.tlong
Only for performance tuning of compute longensive linear algebraic computations.
LongProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
LongProcedure - Interface in cern.colt.function.tlong
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
LongProperty - Class in cern.colt.matrix.tlong.algo
Tests matrices for linear algebraic properties (equality, tridiagonality, symmetry, singularity, etc).
LongProperty() - Constructor for class cern.colt.matrix.tlong.algo.LongProperty
Constructs an instance with a tolerance of Math.abs(newTolerance).
LongSorting - Class in cern.colt.matrix.tlong.algo
Matrix quicksorts and mergesorts.
longTOdouble(long[]) - Static method in class flanagan.math.Fmath
 
longTOfloat(long[]) - Static method in class flanagan.math.Fmath
 
longValue() - Method in class org.apache.commons.math.fraction.BigFraction
Gets the fraction as a long.
longValue() - Method in class org.apache.commons.math.fraction.Fraction
Gets the fraction as a long.
lorentzian() - Method in class flanagan.analysis.Regression
 
lorentzian(double, double, double) - Static method in class flanagan.analysis.Stat
 
lorentzianArray(double, double, int) - Method in class flanagan.math.PsRandom
 
lorentzianCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
LorentzianCoreNotNorm - Class in hep.aida.ref.function
 
LorentzianCoreNotNorm(String) - Constructor for class hep.aida.ref.function.LorentzianCoreNotNorm
 
LorentzianCoreNotNorm(String, double[]) - Constructor for class hep.aida.ref.function.LorentzianCoreNotNorm
 
lorentzianInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
lorentzianOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
lorentzianPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
lorentzianPlot() - Method in class flanagan.analysis.Regression
 
lorentzianProb(double, double, double) - Static method in class flanagan.analysis.Stat
 
lorentzianProb(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
lorentzianRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
lorentzianRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
lowerBandwidth(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
The lower bandwidth of a square matrix A is the maximum i-j for which A[i,j] is nonzero and i > j.
lowerBandwidth(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
The lower bandwidth of a square matrix A is the maximum i-j for which A[i,j] is nonzero and i > j.
lowerBandwidth(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
The lower bandwidth of a square matrix A is the maximum i-j for which A[i,j] is nonzero and i > j.
lowerBandwidth(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
The lower bandwidth of a square matrix A is the maximum i-j for which A[i,j] is nonzero and i > j.
lowerBandwidth(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
The lower bandwidth of a square matrix A is the maximum i-j for which A[i,j] is nonzero and i > j.
lowerBound() - Method in class hep.aida.ref.fitter.FitParameterSettings
 
lowerBound() - Method in class hep.aida.ref.function.Range
Get the lower bound.
lowerBounds() - Method in class hep.aida.ref.function.RangeSet
Return array of lower or upper Bounds for the current set of ranges
lowerEdge() - Method in class cern.hep.aida.ref.FixedAxis
 
lowerEdge() - Method in class cern.hep.aida.ref.VariableAxis
 
lowerEdge() - Method in class hep.aida.ref.histogram.Cloud1D
Get the Cloud's lower edge.
lowerEdge() - Method in class hep.aida.ref.histogram.FixedAxis
Get the Axis lower edge.
lowerEdge() - Method in class hep.aida.ref.histogram.VariableAxis
 
lowerEdge() - Method in interface hep.aida.tdouble.DoubleIAxis
Lower axis edge.
lowerEdge() - Method in class hep.aida.tdouble.ref.DoubleFixedAxis
 
lowerEdge() - Method in class hep.aida.tdouble.ref.DoubleVariableAxis
 
lowerEdge() - Method in interface hep.aida.tfloat.FloatIAxis
Lower axis edge.
lowerEdge() - Method in class hep.aida.tfloat.ref.FloatFixedAxis
 
lowerEdge() - Method in class hep.aida.tfloat.ref.FloatVariableAxis
 
lowerEdgeWithMargin() - Method in class hep.aida.ref.histogram.Cloud1D
 
lowerEdgeX() - Method in class hep.aida.ref.histogram.Cloud2D
Get the Cloud's x lower edge.
lowerEdgeX() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's x lower edge.
lowerEdgeXWithMargin() - Method in class hep.aida.ref.histogram.Cloud2D
 
lowerEdgeXWithMargin() - Method in class hep.aida.ref.histogram.Cloud3D
 
lowerEdgeY() - Method in class hep.aida.ref.histogram.Cloud2D
Get the Cloud's y lower edge.
lowerEdgeY() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's y lower edge.
lowerEdgeYWithMargin() - Method in class hep.aida.ref.histogram.Cloud2D
 
lowerEdgeYWithMargin() - Method in class hep.aida.ref.histogram.Cloud3D
 
lowerEdgeZ() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's z lower edge.
lowerEdgeZWithMargin() - Method in class hep.aida.ref.histogram.Cloud3D
 
lowerExtent(int) - Method in class hep.aida.ref.histogram.DataPoint
Get the lower value for a give axis.
lowerExtent(int) - Method in class hep.aida.ref.histogram.DataPointSet
 
lowerOutliersAnscombe(double) - Method in class flanagan.analysis.Stat
 
lowerOutliersAnscombe(BigDecimal) - Method in class flanagan.analysis.Stat
 
lowerOutliersAnscombe(BigInteger) - Method in class flanagan.analysis.Stat
 
lowerOutliersAnscombe(double[], double) - Static method in class flanagan.analysis.Stat
 
lowerOutliersAnscombe(BigDecimal[], BigDecimal) - Static method in class flanagan.analysis.Stat
 
lowerOutliersAnscombe(BigInteger[], BigInteger) - Static method in class flanagan.analysis.Stat
 
lowerOutliersAnscombe_as_BigDecimal(BigDecimal) - Method in class flanagan.analysis.Stat
 
lowerOutliersAnscombe_as_BigDecimal(BigInteger) - Method in class flanagan.analysis.Stat
 
lowerOutliersAnscombe_as_double(double) - Method in class flanagan.analysis.Stat
 
lowerOutliersAnscombeAsArrayList(double[], double) - Static method in class flanagan.analysis.Stat
 
lowerOutliersAnscombeAsArrayList(BigDecimal[], BigDecimal) - Static method in class flanagan.analysis.Stat
 
lowerOutliersAnscombeAsArrayList(BigInteger[], BigInteger) - Static method in class flanagan.analysis.Stat
 
lowerOutliersAnscombeAsVector(double[], double) - Static method in class flanagan.analysis.Stat
 
lowerOutliersAnscombeAsVector(BigDecimal[], BigDecimal) - Static method in class flanagan.analysis.Stat
 
lowerOutliersAnscombeAsVector(BigInteger[], BigInteger) - Static method in class flanagan.analysis.Stat
 
LParticle - Class in hephysics.particle
a light-weight Lorentz-type particle based on four-Lorentz vector.
LParticle(String, double) - Constructor for class hephysics.particle.LParticle
Define a particle with a name and mass
LParticle(double, double, double) - Constructor for class hephysics.particle.LParticle
Define a 3-momentum or X,Y,Z position.
LParticle(double, double, double, double, double) - Constructor for class hephysics.particle.LParticle
Define a particle in momentum or coordinate space.
LParticle(double, double, double, double) - Constructor for class hephysics.particle.LParticle
Define a particle in momentum or 4-space time.
LParticle(String, double, double, double, double, double) - Constructor for class hephysics.particle.LParticle
Define a Lorentz particle in momentum or coordinate space.
ls() - Method in class hep.aida.ref.tree.Tree
List, into a given output stream, all the IManagedObjects, including directories (but not "." and ".."), in a given path.
ls(String) - Method in class hep.aida.ref.tree.Tree
List, into a given output stream, all the IManagedObjects, including directories (but not "." and ".."), in a given path.
ls(String, boolean) - Method in class hep.aida.ref.tree.Tree
List, into a given output stream, all the IManagedObjects, including directories (but not "." and ".."), in a given path.
ls(String, boolean, OutputStream) - Method in class hep.aida.ref.tree.Tree
List, into a given output stream, all the IManagedObjects, including directories (but not "." and ".."), in a given path.
lsame(String, String) - Method in class org.netlib.blas.BLAS
..
lsame(String, String) - Method in class org.netlib.lapack.LAPACK
..
lsamen(int, String, String) - Method in class org.netlib.lapack.LAPACK
..
lu(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Constructs and returns the LU-decomposition of the given matrix.
lu(DoubleMatrix2D, int) - Method in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Constructs and returns the LU-decomposition of the given matrix.
lu(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Constructs and returns the LU-decomposition of the given matrix.
lu(FloatMatrix2D, int) - Method in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Constructs and returns the LU-decomposition of the given matrix.
LU(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
luBackSub(double[]) - Method in class flanagan.math.Matrix
 
luDecomp() - Method in class flanagan.math.Matrix
 
luDecompose() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Deprecated. as of release 2.0, replaced by LUDecomposition
luDecompose() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Computes a new LU decompostion for this matrix, storing the result for use by other methods.
LUDecomposition - Class in cern.colt.matrix.linalg
For an m x n matrix A with m >= n, the LU decomposition is an m x n unit lower triangular matrix L, an n x n upper triangular matrix U, and a permutation vector piv of length m so that A(piv,:) = L*U; If m < n, then L is m x m and U is m x n.
LUDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.linalg.LUDecomposition
Constructs and returns a new LU Decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
LUDecomposition - Class in jhplot.math
LU Decomposition.
LUDecomposition(double[][]) - Constructor for class jhplot.math.LUDecomposition
LU Decomposition
LUDecomposition - Interface in org.apache.commons.math.linear
An interface to classes that implement an algorithm to calculate the LU-decomposition of a real matrix.
LUDecompositionImpl - Class in org.apache.commons.math.linear
Calculates the LUP-decomposition of a square matrix.
LUDecompositionImpl(RealMatrix) - Constructor for class org.apache.commons.math.linear.LUDecompositionImpl
Calculates the LU-decomposition of the given matrix.
LUDecompositionImpl(RealMatrix, double) - Constructor for class org.apache.commons.math.linear.LUDecompositionImpl
Calculates the LU-decomposition of the given matrix.
LUDecompositionQuick - Class in cern.colt.matrix.linalg
A low level version of LUDecomposition, avoiding unnecessary memory allocation and copying.
LUDecompositionQuick() - Constructor for class cern.colt.matrix.linalg.LUDecompositionQuick
Constructs and returns a new LU Decomposition object with default tolerance 1.0E-9 for singularity detection.
LUDecompositionQuick(double) - Constructor for class cern.colt.matrix.linalg.LUDecompositionQuick
Constructs and returns a new LU Decomposition object which uses the given tolerance for singularity detection;
lumen - Static variable in class cern.clhep.Units
 
lux - Static variable in class cern.clhep.Units
 

M

m - Static variable in class cern.clhep.Units
 
m() - Method in class hephysics.vec.HepLorentzVector
Invariant mass.
m2 - Static variable in class cern.clhep.Units
 
m2() - Method in class hephysics.vec.HepLorentzVector
Invariant mass squared
m3 - Static variable in class cern.clhep.Units
 
M_ELECTRON - Static variable in class flanagan.math.Fmath
 
M_NEUTRON - Static variable in class flanagan.math.Fmath
 
M_PROTON - Static variable in class flanagan.math.Fmath
 
mag() - Method in class hephysics.vec.Hep3Vector
 
mag() - Method in class hephysics.vec.HepLorentzVector
Magnitude sqrt(x**2+y**2+z**2)
mag2() - Method in class hephysics.vec.Hep3Vector
 
mag2() - Method in class hephysics.vec.HepLorentzVector
Magnitude squared: t()*t() - v.mag2() or e()*e() - v.mag2().
magnitude() - Method in class hephysics.vec.SpacePoint
 
magnitudeSquared() - Method in class hephysics.vec.Hep3Vector
 
magnitudeSquared() - Method in class hephysics.vec.SpacePoint
 
main(String[]) - Static method in class cern.colt.map.Benchmark
Tests various methods of this class.
main(String[]) - Static method in class cern.colt.matrix.bench.BenchmarkMatrix
Runs the matrix benchmark operations defined in args or in the file specified by args0.
main(String[]) - Static method in class cern.colt.matrix.doublealgo.Statistic
Benchmarks covariance computation.
main(String[]) - Static method in class cern.colt.matrix.tdouble.algo.DoubleSorting
 
main(String[]) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Benchmarks covariance computation.
main(String[]) - Static method in class cern.colt.matrix.tfloat.algo.FloatSorting
 
main(String[]) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Benchmarks covariance computation.
main(String[]) - Static method in class cern.colt.Version
Prints asString on System.out.
main(String[]) - Static method in class cern.hep.aida.ref.Test
 
main(String[]) - Static method in class cern.hep.aida.ref.Test2
 
main(String[]) - Static method in class cern.jet.random.Benchmark
Benchmarks all subclasses
main(String[]) - Static method in class cern.jet.random.engine.Benchmark
Tests various methods of this class.
main(String[]) - Static method in class cern.jet.random.engine.RandomSeedGenerator
Prints the generated seeds for the given input parameters.
main(String[]) - Static method in class cern.jet.random.sampling.RandomSampler
Tests this class.
main(String[]) - Static method in class cern.jet.random.sampling.RandomSamplingAssistant
Tests random sampling.
main(String[]) - Static method in class cern.jet.random.tdouble.engine.RandomSeedGenerator
Prints the generated seeds for the given input parameters.
main(String[]) - Static method in class cern.jet.random.tdouble.sampling.DoubleRandomSampler
Tests this class.
main(String[]) - Static method in class cern.jet.random.tdouble.sampling.DoubleRandomSamplingAssistant
Tests random sampling.
main(String[]) - Static method in class cern.jet.random.tfloat.sampling.FloatRandomSampler
Tests this class.
main(String[]) - Static method in class cern.jet.random.tfloat.sampling.FloatRandomSamplingAssistant
Tests random sampling.
main(String[]) - Static method in class cern.jet.stat.quantile.Quantile1Test
 
main(String[]) - Static method in class hep.aida.ref.fitter.Fitter
 
main(String[]) - Static method in class hep.aida.ref.function.examples.NonParametricUnbinnedFit
 
main(String[]) - Static method in class hep.aida.ref.function.FunctionCatalog
 
main(String[]) - Static method in class hep.aida.ref.function.UserFunction
 
main(String[]) - Static method in class jhplot.bsom.MainFrame
 
main(String[]) - Static method in class jhplot.bsom.MainFrameDemo
 
main(String[]) - Static method in class jhplot.HPlotJa
The main method of japlot.jaxodraw: determines system properties, preferences and command line arguments, before bringing up the graphical user interface.
main(String[]) - Static method in class jhplot.math.DoubleArray
 
main(String[]) - Static method in class jhplot.math.io.ASCIIFile
 
main(String[]) - Static method in class jhplot.math.io.BinaryFile
 
main(String[]) - Static method in class jhplot.math.KolmogorovSmirnovDist
 
main(String[]) - Static method in class jhplot.math.Poisson
 
main(String[]) - Static method in class jhplot.math.Slicing
 
main(String[]) - Static method in class jhplot.math.Sorting
 
main(String[]) - Static method in class jhplot.math.SortUtils
Test method
main(String[]) - Static method in class jhplot.PND
Test
main(String[]) - Static method in class jhplot.PNI
Test
main(String[]) - Static method in class jhplot.root.RootHistogramBrowser
 
main(String[]) - Static method in class jhplot.SPlot
 
main(String[]) - Static method in class jhplot.stat.PCA
 
main(String[]) - Static method in class jhplot.v3d.TestCanvas
 
main(String[]) - Static method in class jhpro.stat.limit.LimitCalculatorGui
 
main(String[]) - Static method in class jhpro.test.TestCalculator
 
main(String[]) - Static method in class jhpro.test.TestLimit
 
main(String[]) - Static method in class jminhep.cluster.DataHolder
Main method -- to test the DataPoint class
main(String[]) - Static method in class jminhep.cluster.DataPoint
Main method -- to test the DataPoint class
main(String[]) - Static method in class org.netlib.utils.JNIMethods
 
main(String[]) - Static method in class umontreal.iro.lecuyer.rng.GenF2w32
This method is only meant to be used during the compilation process.
main(String[]) - Static method in class umontreal.iro.lecuyer.rng.WELL1024
 
main(String[]) - Static method in class umontreal.iro.lecuyer.rng.WELL512
This method is only meant to be used during the compilation process.
main(String[]) - Static method in class umontreal.iro.lecuyer.rng.WELL607
 
main2(String[]) - Static method in class cern.hep.aida.ref.Test2
 
MainFrame - Class in jhplot.bsom
 
MainFrame() - Constructor for class jhplot.bsom.MainFrame
 
MainFrameDemo - Class in jhplot.bsom
 
MainFrameDemo() - Constructor for class jhplot.bsom.MainFrameDemo
 
make(double[]) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with the given cell values.
make(DoubleMatrix1D[]) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(int) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, double) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(AbstractDoubleList) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix from the values of the given list.
make(double[][]) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with the given cell values.
make(double[], int) - Method in class cern.colt.matrix.DoubleFactory2D
Construct a matrix from a one-dimensional column-major packed array, ala Fortran.
make(int, int) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, double) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(double[][][]) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, double) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(ObjectMatrix1D[]) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(Object[]) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a matrix with the given cell values.
make(int) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, Object) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(ObjectArrayList) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a matrix from the values of the given list.
make(Object[][]) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a matrix with the given cell values.
make(Object[], int) - Method in class cern.colt.matrix.ObjectFactory2D
Construct a matrix from a one-dimensional column-major packed array, ala Fortran.
make(int, int) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, Object) - Method in class cern.colt.matrix.ObjectFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(Object[][][]) - Method in class cern.colt.matrix.ObjectFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.ObjectFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, Object) - Method in class cern.colt.matrix.ObjectFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory1D
Constructs a matrix with the given cell values.
make(DComplexMatrix1D[]) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(int) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(ArrayList<double[]>) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory1D
Constructs a matrix from the values of the given list.
make(double[][]) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a matrix with the given cell values.
make(int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(double[][][]) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(AbstractDoubleList) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
Constructs a matrix from the values of the given list.
make(double[]) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
Constructs a matrix with the given cell values.
make(DoubleMatrix1D[]) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(int) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, double) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(double[], int) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Construct a matrix from a one-dimensional column-major packed array, ala Fortran.
make(double[][]) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a matrix with the given cell values.
make(int, int) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, double) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(double[][][]) - Method in class cern.colt.matrix.tdouble.DoubleFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, double) - Method in class cern.colt.matrix.tdouble.DoubleFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory1D
Constructs a matrix with the given cell values.
make(FComplexMatrix1D[]) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(int) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(ArrayList<float[]>) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory1D
Constructs a matrix from the values of the given list.
make(float[][]) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a matrix with the given cell values.
make(int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(float[][][]) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(AbstractFloatList) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
Constructs a matrix from the values of the given list.
make(float[]) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
Constructs a matrix with the given cell values.
make(FloatMatrix1D[]) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(int) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, float) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(float[], int) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Construct a matrix from a one-dimensional column-major packed array, ala Fortran.
make(float[][]) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a matrix with the given cell values.
make(int, int) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, float) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(float[][][]) - Method in class cern.colt.matrix.tfloat.FloatFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.tfloat.FloatFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, float) - Method in class cern.colt.matrix.tfloat.FloatFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(int[]) - Method in class cern.colt.matrix.tint.IntFactory1D
Constructs a matrix with the given cell values.
make(IntMatrix1D[]) - Method in class cern.colt.matrix.tint.IntFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(int) - Method in class cern.colt.matrix.tint.IntFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int) - Method in class cern.colt.matrix.tint.IntFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(AbstractIntList) - Method in class cern.colt.matrix.tint.IntFactory1D
Constructs a matrix from the values of the given list.
make(int[][]) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a matrix with the given cell values.
make(int[], int) - Method in class cern.colt.matrix.tint.IntFactory2D
Construct a matrix from a one-dimensional column-major packed array, ala Fortran.
make(int, int) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(int[][][]) - Method in class cern.colt.matrix.tint.IntFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.tint.IntFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, int) - Method in class cern.colt.matrix.tint.IntFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(long[]) - Method in class cern.colt.matrix.tlong.LongFactory1D
Constructs a matrix with the given cell values.
make(LongMatrix1D[]) - Method in class cern.colt.matrix.tlong.LongFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(int) - Method in class cern.colt.matrix.tlong.LongFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, long) - Method in class cern.colt.matrix.tlong.LongFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(AbstractLongList) - Method in class cern.colt.matrix.tlong.LongFactory1D
Constructs a matrix from the values of the given list.
make(long[][]) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a matrix with the given cell values.
make(int[], int) - Method in class cern.colt.matrix.tlong.LongFactory2D
Construct a matrix from a one-dimensional column-major packed array, ala Fortran.
make(int, int) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, long) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(long[][][]) - Method in class cern.colt.matrix.tlong.LongFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.tlong.LongFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, long) - Method in class cern.colt.matrix.tlong.LongFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(ObjectMatrix1D[]) - Method in class cern.colt.matrix.tobject.ObjectFactory1D
Constructs a matrix which is the concatenation of all given parts.
make(Object[]) - Method in class cern.colt.matrix.tobject.ObjectFactory1D
Constructs a matrix with the given cell values.
make(int) - Method in class cern.colt.matrix.tobject.ObjectFactory1D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, Object) - Method in class cern.colt.matrix.tobject.ObjectFactory1D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(ObjectArrayList) - Method in class cern.colt.matrix.tobject.ObjectFactory1D
Constructs a matrix from the values of the given list.
make(Object[][]) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
Constructs a matrix with the given cell values.
make(Object[], int) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
Construct a matrix from a one-dimensional column-major packed array, ala Fortran.
make(int, int) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, Object) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
Constructs a matrix with the given shape, each cell initialized with the given value.
make(Object[][][]) - Method in class cern.colt.matrix.tobject.ObjectFactory3D
Constructs a matrix with the given cell values.
make(int, int, int) - Method in class cern.colt.matrix.tobject.ObjectFactory3D
Constructs a matrix with the given shape, each cell initialized with zero.
make(int, int, int, Object) - Method in class cern.colt.matrix.tobject.ObjectFactory3D
Constructs a matrix with the given shape, each cell initialized with the given value.
makeBitVector(int, int) - Static method in class cern.colt.bitvector.QuickBitVector
Constructs a low level bitvector that holds size elements, with each element taking bitsPerElement bits.
makeBitVector(int, int) - Static method in class cern.colt.matrix.tbit.QuickBitVector
Constructs a low level bitvector that holds size elements, with each element taking bitsPerElement bits.
makeDefault() - Static method in class cern.jet.random.engine.RandomEngine
Constructs and returns a new uniform random number engine seeded with the current time.
makeDefault() - Static method in class cern.jet.random.tdouble.engine.DoubleRandomEngine
Constructs and returns a new uniform random number engine seeded with the current time.
makeDefault() - Static method in class cern.jet.random.tfloat.engine.FloatRandomEngine
Constructs and returns a new uniform random number engine seeded with the current time.
makeDefaultGenerator() - Static method in class cern.jet.random.AbstractDistribution
Constructs and returns a new uniform random number generation engine seeded with the current time.
makeDefaultGenerator() - Static method in class cern.jet.random.tdouble.AbstractDoubleDistribution
Constructs and returns a new uniform random number generation engine seeded with the current time.
makeDefaultGenerator() - Static method in class cern.jet.random.tfloat.AbstractFloatDistribution
Constructs and returns a new uniform random number generation engine seeded with the current time.
ManagedObject - Class in hep.aida.ref
An object which can be stored in a tree.
ManagedObject(String) - Constructor for class hep.aida.ref.ManagedObject
Creates a new instance of ManagedObject.
MANHATTAN - Static variable in class cern.colt.matrix.doublealgo.Statistic
Manhattan distance function; Sum( abs(x[i]-y[i]) ).
MANHATTAN - Static variable in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Manhattan distance function; Sum( abs(x[i]-y[i]) ).
MANHATTAN - Static variable in class cern.colt.matrix.tfloat.algo.FloatStatistic
Manhattan distance function; Sum( abs(x[i]-y[i]) ).
map(UnivariateRealFunction) - Method in class org.apache.commons.math.linear.AbstractRealVector
Acts as if implemented as:
map(UnivariateRealFunction) - Method in interface org.apache.commons.math.linear.RealVector
Acts as if implemented as:
mapAbs() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.abs(double) function to each entry.
mapAbs() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapAbsToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.abs(double) function to each entry.
mapAbsToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.abs(double) function to each entry.
mapAbsToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapAcos() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.acos(double) function to each entry.
mapAcos() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapAcosToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.acos(double) function to each entry.
mapAcosToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.acos(double) function to each entry.
mapAcosToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapAdd(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Add a value to each entry.
mapAdd(T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Map an addition operation to each entry.
mapAdd(T) - Method in interface org.apache.commons.math.linear.FieldVector
Map an addition operation to each entry.
mapAdd(double) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Add a value to each entry.
mapAdd(double) - Method in interface org.apache.commons.math.linear.RealVector
Add a value to each entry.
mapAdd(T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Map an addition operation to each entry.
mapAddToSelf(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Add a value to each entry.
mapAddToSelf(T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Map an addition operation to each entry.
mapAddToSelf(double) - Method in class org.apache.commons.math.linear.ArrayRealVector
Add a value to each entry.
mapAddToSelf(T) - Method in interface org.apache.commons.math.linear.FieldVector
Map an addition operation to each entry.
mapAddToSelf(double) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Add a value to each entry.
mapAddToSelf(double) - Method in interface org.apache.commons.math.linear.RealVector
Add a value to each entry.
mapAddToSelf(T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Map an addition operation to each entry.
mapAsin() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.asin(double) function to each entry.
mapAsin() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapAsinToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.asin(double) function to each entry.
mapAsinToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.asin(double) function to each entry.
mapAsinToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapAtan() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.atan(double) function to each entry.
mapAtan() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapAtanToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.atan(double) function to each entry.
mapAtanToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.atan(double) function to each entry.
mapAtanToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapBinNumber(int, IAxis) - Method in class hep.aida.ref.histogram.AbstractBaseHistogram
Utility method to map the bin number from the external representation (from -2 to nBins-1 where -2 is the overflow and -1 is the underflow) to the internal one (from 0 to nBins+1 where 0 is the underflow and nBins+1 if the overflow bin)
mapBinNumber(int, IAxis) - Method in class jhplot.HProf2D
Utility method to map the bin number from the external representation (from -2 to nBins-1 where -2 is the overflow and -1 is the underflow) to the internal one (from 0 to nBins+1 where 0 is the underflow and nBins+1 if the overflow bin)
mapCbrt() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.cbrt(double) function to each entry.
mapCbrt() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapCbrtToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.cbrt(double) function to each entry.
mapCbrtToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.cbrt(double) function to each entry.
mapCbrtToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapCeil() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.ceil(double) function to each entry.
mapCeil() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapCeilToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.ceil(double) function to each entry.
mapCeilToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.ceil(double) function to each entry.
mapCeilToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapCos() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.cos(double) function to each entry.
mapCos() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapCosh() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.cosh(double) function to each entry.
mapCosh() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapCoshToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.cosh(double) function to each entry.
mapCoshToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.cosh(double) function to each entry.
mapCoshToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapCosToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.cos(double) function to each entry.
mapCosToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.cos(double) function to each entry.
mapCosToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapDivide(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Divide each entry.
mapDivide(T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Map a division operation to each entry.
mapDivide(T) - Method in interface org.apache.commons.math.linear.FieldVector
Map a division operation to each entry.
mapDivide(double) - Method in interface org.apache.commons.math.linear.RealVector
Divide each entry.
mapDivide(T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Map a division operation to each entry.
mapDivideToSelf(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Divide each entry.
mapDivideToSelf(T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Map a division operation to each entry.
mapDivideToSelf(double) - Method in class org.apache.commons.math.linear.ArrayRealVector
Divide each entry.
mapDivideToSelf(T) - Method in interface org.apache.commons.math.linear.FieldVector
Map a division operation to each entry.
mapDivideToSelf(double) - Method in interface org.apache.commons.math.linear.RealVector
Divide each entry.
mapDivideToSelf(T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Map a division operation to each entry.
mapExp() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.exp(double) function to each entry.
mapExp() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapExpm1() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.expm1(double) function to each entry.
mapExpm1() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapExpm1ToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.expm1(double) function to each entry.
mapExpm1ToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.expm1(double) function to each entry.
mapExpm1ToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapExpToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map Math.exp(double) operation to each entry.
mapExpToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map Math.exp(double) operation to each entry.
mapExpToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapFloor() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.floor(double) function to each entry.
mapFloor() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapFloorToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.floor(double) function to each entry.
mapFloorToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.floor(double) function to each entry.
mapFloorToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapInv() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the 1/x function to each entry.
mapInv() - Method in class org.apache.commons.math.linear.ArrayFieldVector
Map the 1/x function to each entry.
mapInv() - Method in interface org.apache.commons.math.linear.FieldVector
Map the 1/x function to each entry.
mapInv() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapInv() - Method in class org.apache.commons.math.linear.SparseFieldVector
Map the 1/x function to each entry.
mapInvToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the 1/x function to each entry.
mapInvToSelf() - Method in class org.apache.commons.math.linear.ArrayFieldVector
Map the 1/x function to each entry.
mapInvToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the 1/x function to each entry.
mapInvToSelf() - Method in interface org.apache.commons.math.linear.FieldVector
Map the 1/x function to each entry.
mapInvToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapInvToSelf() - Method in class org.apache.commons.math.linear.SparseFieldVector
Map the 1/x function to each entry.
mapLog() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.log(double) function to each entry.
mapLog() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapLog10() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.log10(double) function to each entry.
mapLog10() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapLog10ToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.log10(double) function to each entry.
mapLog10ToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.log10(double) function to each entry.
mapLog10ToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapLog1p() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.log1p(double) function to each entry.
mapLog1p() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapLog1pToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.log1p(double) function to each entry.
mapLog1pToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.log1p(double) function to each entry.
mapLog1pToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapLogToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.log(double) function to each entry.
mapLogToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.log(double) function to each entry.
mapLogToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapMultiply(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Multiply each entry.
mapMultiply(T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Map a multiplication operation to each entry.
mapMultiply(T) - Method in interface org.apache.commons.math.linear.FieldVector
Map a multiplication operation to each entry.
mapMultiply(double) - Method in interface org.apache.commons.math.linear.RealVector
Multiply each entry.
mapMultiply(T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Map a multiplication operation to each entry.
mapMultiplyToSelf(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Multiply each entry.
mapMultiplyToSelf(T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Map a multiplication operation to each entry.
mapMultiplyToSelf(double) - Method in class org.apache.commons.math.linear.ArrayRealVector
Multiply each entry.
mapMultiplyToSelf(T) - Method in interface org.apache.commons.math.linear.FieldVector
Map a multiplication operation to each entry.
mapMultiplyToSelf(double) - Method in interface org.apache.commons.math.linear.RealVector
Multiply each entry.
mapMultiplyToSelf(T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Map a multiplication operation to each entry.
mapNames() - Method in class jhplot.io.PFile
Generate an association between record number and object name.
MappingStrategy - Interface in jhplot.io.csv.bean
 
mapPow(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Map a power operation to each entry.
mapPow(double) - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapPowToSelf(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Map a power operation to each entry.
mapPowToSelf(double) - Method in class org.apache.commons.math.linear.ArrayRealVector
Map a power operation to each entry.
mapPowToSelf(double) - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapRint() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.rint(double) function to each entry.
mapRint() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapRintToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.rint(double) function to each entry.
mapRintToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.rint(double) function to each entry.
mapRintToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapSignum() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.signum(double) function to each entry.
mapSignum() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapSignumToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.signum(double) function to each entry.
mapSignumToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.signum(double) function to each entry.
mapSignumToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapSin() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.sin(double) function to each entry.
mapSin() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapSinh() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.sinh(double) function to each entry.
mapSinh() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapSinhToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.sinh(double) function to each entry.
mapSinhToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.sinh(double) function to each entry.
mapSinhToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapSinToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.sin(double) function to each entry.
mapSinToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.sin(double) function to each entry.
mapSinToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapSqrt() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.sqrt(double) function to each entry.
mapSqrt() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapSqrtToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.sqrt(double) function to each entry.
mapSqrtToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.sqrt(double) function to each entry.
mapSqrtToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapSubtract(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Subtract a value from each entry.
mapSubtract(T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Map a subtraction operation to each entry.
mapSubtract(T) - Method in interface org.apache.commons.math.linear.FieldVector
Map a subtraction operation to each entry.
mapSubtract(double) - Method in interface org.apache.commons.math.linear.RealVector
Subtract a value from each entry.
mapSubtract(T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Map a subtraction operation to each entry.
mapSubtractToSelf(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Subtract a value from each entry.
mapSubtractToSelf(T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Map a subtraction operation to each entry.
mapSubtractToSelf(double) - Method in class org.apache.commons.math.linear.ArrayRealVector
Subtract a value from each entry.
mapSubtractToSelf(T) - Method in interface org.apache.commons.math.linear.FieldVector
Map a subtraction operation to each entry.
mapSubtractToSelf(double) - Method in interface org.apache.commons.math.linear.RealVector
Subtract a value from each entry.
mapSubtractToSelf(T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Map a subtraction operation to each entry.
mapTan() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.tan(double) function to each entry.
mapTan() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapTanh() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.tanh(double) function to each entry.
mapTanh() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapTanhToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.tanh(double) function to each entry.
mapTanhToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.tanh(double) function to each entry.
mapTanhToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapTanToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.tan(double) function to each entry.
mapTanToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.tan(double) function to each entry.
mapTanToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapToSelf(UnivariateRealFunction) - Method in class org.apache.commons.math.linear.AbstractRealVector
Acts as if it is implemented as:
mapToSelf(UnivariateRealFunction) - Method in interface org.apache.commons.math.linear.RealVector
Acts as if it is implemented as:
mapUlp() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.ulp(double) function to each entry.
mapUlp() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mapUlpToSelf() - Method in class org.apache.commons.math.linear.AbstractRealVector
Map the Math.ulp(double) function to each entry.
mapUlpToSelf() - Method in class org.apache.commons.math.linear.ArrayRealVector
Map the Math.ulp(double) function to each entry.
mapUlpToSelf() - Method in interface org.apache.commons.math.linear.RealVector
Deprecated. in 2.2 (to be removed in 3.0).
mass() - Method in class hephysics.particle.LParticle
Get a mass
mass(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the sum of the elements of the array.
mass(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the sum of the elements of the array.
MathConfigurationException - Exception in org.apache.commons.math
Signals a configuration problem with any of the factory methods.
MathConfigurationException() - Constructor for exception org.apache.commons.math.MathConfigurationException
Default constructor.
MathConfigurationException(String, Object...) - Constructor for exception org.apache.commons.math.MathConfigurationException
Constructs an exception with specified formatted detail message.
MathConfigurationException(Localizable, Object...) - Constructor for exception org.apache.commons.math.MathConfigurationException
Constructs an exception with specified formatted detail message.
MathConfigurationException(Throwable) - Constructor for exception org.apache.commons.math.MathConfigurationException
Create an exception with a given root cause.
MathConfigurationException(Throwable, String, Object...) - Constructor for exception org.apache.commons.math.MathConfigurationException
Constructs an exception with specified formatted detail message and root cause.
MathConfigurationException(Throwable, Localizable, Object...) - Constructor for exception org.apache.commons.math.MathConfigurationException
Constructs an exception with specified formatted detail message and root cause.
MATHEMATICA - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Data file format used for creating graphics with Mathematica.
MATHEMATICA - Static variable in class umontreal.iro.lecuyer.util.TableFormat
Mathematica matrix printing style
MathException - Exception in org.apache.commons.math
Base class for commons-math checked exceptions.
MathException() - Constructor for exception org.apache.commons.math.MathException
Constructs a new MathException with no detail message.
MathException(String, Object...) - Constructor for exception org.apache.commons.math.MathException
Deprecated. as of 2.2 replaced by MathException.MathException(Localizable, Object...)
MathException(Localizable, Object...) - Constructor for exception org.apache.commons.math.MathException
Constructs a new MathException with specified formatted detail message.
MathException(Throwable) - Constructor for exception org.apache.commons.math.MathException
Constructs a new MathException with specified nested Throwable root cause.
MathException(Throwable, String, Object...) - Constructor for exception org.apache.commons.math.MathException
Deprecated. as of 2.2 replaced by MathException.MathException(Throwable, Localizable, Object...)
MathException(Throwable, Localizable, Object...) - Constructor for exception org.apache.commons.math.MathException
Constructs a new MathException with specified formatted detail message and nested Throwable root cause.
Mathfun - Class in jhplot.math
 
Mathfun() - Constructor for class jhplot.math.Mathfun
 
MathFunction - Interface in umontreal.iro.lecuyer.functions
This interface should be implemented by classes which represent univariate mathematical functions.
MathFunctionUtil - Class in umontreal.iro.lecuyer.functions
Provides utility methods for computing derivatives and integrals of functions.
MathFunctionWithDerivative - Interface in umontreal.iro.lecuyer.functions
Represents a mathematical function whose nth derivative can be computed using derivative.
MathFunctionWithFirstDerivative - Interface in umontreal.iro.lecuyer.functions
Represents a mathematical function whose derivative can be computed using derivative.
MathFunctionWithIntegral - Interface in umontreal.iro.lecuyer.functions
Represents a mathematical function whose integral can be computed by the integral method.
MathIllegalArgumentException - Exception in org.apache.commons.math.exception
Base class for all preconditions violation exceptions.
MathIllegalNumberException - Exception in org.apache.commons.math.exception
Base class for exceptions raised by a wrong number.
MathIllegalStateException - Exception in org.apache.commons.math.exception
Base class for all exceptions that signal a mismatch between the current state and the user's expectations.
MathIllegalStateException(Localizable, Localizable, Object...) - Constructor for exception org.apache.commons.math.exception.MathIllegalStateException
Simple constructor.
MathIllegalStateException(Throwable, Localizable, Localizable, Object...) - Constructor for exception org.apache.commons.math.exception.MathIllegalStateException
Simple constructor.
MathIllegalStateException(Localizable, Object...) - Constructor for exception org.apache.commons.math.exception.MathIllegalStateException
 
MathIllegalStateException(Throwable, Localizable, Object...) - Constructor for exception org.apache.commons.math.exception.MathIllegalStateException
Simple constructor.
MathInternalError - Exception in org.apache.commons.math.exception
Exception triggered when something that shouldn't happen does happen.
MathInternalError() - Constructor for exception org.apache.commons.math.exception.MathInternalError
Simple constructor.
MathInternalError(Throwable) - Constructor for exception org.apache.commons.math.exception.MathInternalError
Simple constructor.
MathRNG - Class in jhplot.math.num.random
A random number generator that delegates random number generation to the Math.random() method.
MathRNG() - Constructor for class jhplot.math.num.random.MathRNG
 
MathRuntimeException - Exception in org.apache.commons.math
Base class for commons-math unchecked exceptions.
MathRuntimeException(String, Object...) - Constructor for exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.MathRuntimeException(Localizable, Object...)
MathRuntimeException(Localizable, Object...) - Constructor for exception org.apache.commons.math.MathRuntimeException
Constructs a new MathRuntimeException with specified formatted detail message.
MathRuntimeException(Throwable) - Constructor for exception org.apache.commons.math.MathRuntimeException
Constructs a new MathRuntimeException with specified nested Throwable root cause.
MathRuntimeException(Throwable, String, Object...) - Constructor for exception org.apache.commons.math.MathRuntimeException
Deprecated. as of 2.2 replaced by MathRuntimeException.MathRuntimeException(Throwable, Localizable, Object...)
MathRuntimeException(Throwable, Localizable, Object...) - Constructor for exception org.apache.commons.math.MathRuntimeException
Constructs a new MathRuntimeException with specified formatted detail message and nested Throwable root cause.
MathThrowable - Interface in org.apache.commons.math.exception
Interface for commons-math throwables.
MathUnsupportedOperationException - Exception in org.apache.commons.math.exception
Base class for all unsupported features.
MathUnsupportedOperationException(Object...) - Constructor for exception org.apache.commons.math.exception.MathUnsupportedOperationException
 
MathUnsupportedOperationException(Localizable, Object...) - Constructor for exception org.apache.commons.math.exception.MathUnsupportedOperationException
 
MathUtils - Class in org.apache.commons.math.util
Some useful additions to the built-in functions in Math.
MathUtils.OrderDirection - Enum in org.apache.commons.math.util
Specification of ordering direction.
MATLAB - Static variable in class umontreal.iro.lecuyer.util.TableFormat
Matlab matrix printing style
matMatModM(double[][], double[][], double[][], double) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Computes A×B mod m and puts the result in C.
matMatModM(int[][], int[][], int[][], int) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Exactly like matMatModM using double, but with int instead of double.
matMatModM(long[][], long[][], long[][], long) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Exactly like matMatModM using double, but with long instead of double.
matPowModM(double[][], double[][], double, int) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Computes Ac mod m and puts the result in B.
matPowModM(int[][], int[][], int, int) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Exactly like matPowModM using double, but with int instead of double.
matPowModM(long[][], long[][], long, int) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Exactly like matPowModM using double, but with long instead of double.
Matrix - Class in flanagan.math
 
Matrix(int, int) - Constructor for class flanagan.math.Matrix
 
Matrix(int, int, double) - Constructor for class flanagan.math.Matrix
 
Matrix(double[][]) - Constructor for class flanagan.math.Matrix
 
Matrix(float[][]) - Constructor for class flanagan.math.Matrix
 
Matrix(long[][]) - Constructor for class flanagan.math.Matrix
 
Matrix(int[][]) - Constructor for class flanagan.math.Matrix
 
Matrix(ArrayMaths[]) - Constructor for class flanagan.math.Matrix
 
Matrix(ArrayList<Object>[]) - Constructor for class flanagan.math.Matrix
 
Matrix(Vector<Object>[]) - Constructor for class flanagan.math.Matrix
 
Matrix(BigDecimal[][]) - Constructor for class flanagan.math.Matrix
 
Matrix(BigInteger[][]) - Constructor for class flanagan.math.Matrix
 
Matrix(Matrix) - Constructor for class flanagan.math.Matrix
 
Matrix - Interface in hephysics.matrix
A very simple matrix interface
Matrix - Class in jhplot.bsom
Matrix is a class for matrix objects with basic linear calculation methods.
Matrix(int) - Constructor for class jhplot.bsom.Matrix
Construct a square matrix object.
Matrix(int, int) - Constructor for class jhplot.bsom.Matrix
Construct a rectangle matrix object.
Matrix2DMatrix2DFunction - Interface in cern.colt.matrix.linalg
Interface that represents a function object: a function that takes two arguments and returns a single value.
MatrixIndexException - Exception in org.apache.commons.math.linear
Thrown when an operation addresses a matrix coordinate (row, col) which is outside of the dimensions of a matrix.
MatrixIndexException(String, Object...) - Constructor for exception org.apache.commons.math.linear.MatrixIndexException
Deprecated. as of 2.2 replaced by MatrixIndexException.MatrixIndexException(Localizable, Object...)
MatrixIndexException(Localizable, Object...) - Constructor for exception org.apache.commons.math.linear.MatrixIndexException
Constructs a new instance with specified formatted detail message.
MatrixInfo - Class in cern.colt.matrix.io
Contains information on a matrix in the Matrix Market exchange format.
MatrixInfo(boolean, MatrixInfo.MatrixField, MatrixInfo.MatrixSymmetry) - Constructor for class cern.colt.matrix.io.MatrixInfo
Creates a specific type
MatrixInfo.MatrixField - Enum in cern.colt.matrix.io
What kind of numbers are stored
MatrixInfo.MatrixSymmetry - Enum in cern.colt.matrix.io
Symmetry structure of the matrix, if any
MatrixOp - Class in hephysics.matrix
Simple operations on matrices
MatrixOp.IndeterminateMatrixException - Exception in hephysics.matrix
 
MatrixOp.IndeterminateMatrixException() - Constructor for exception hephysics.matrix.MatrixOp.IndeterminateMatrixException
 
MatrixOp.InvalidMatrixException - Exception in hephysics.matrix
 
MatrixOp.InvalidMatrixException(String) - Constructor for exception hephysics.matrix.MatrixOp.InvalidMatrixException
 
MatrixSize - Class in cern.colt.matrix.io
Contains the size of a matrix stored in the Matrix Market exchange format
MatrixSize(int, int, MatrixInfo) - Constructor for class cern.colt.matrix.io.MatrixSize
Constructor for MatrixSize
MatrixSize(int, int, int) - Constructor for class cern.colt.matrix.io.MatrixSize
Constructor for MatrixSize
MatrixUtils - Class in org.apache.commons.math.linear
A collection of static methods that operate on or return matrices.
MatrixVectorReader - Class in cern.colt.matrix.io
Reads matrices and vectors
MatrixVectorReader(Reader) - Constructor for class cern.colt.matrix.io.MatrixVectorReader
Constructor for MatrixVectorReader
MatrixVectorReader(Reader, int) - Constructor for class cern.colt.matrix.io.MatrixVectorReader
Constructor for MatrixVectorReader
MatrixVectorWriter - Class in cern.colt.matrix.io
Writes matrices and vectors
MatrixVectorWriter(OutputStream) - Constructor for class cern.colt.matrix.io.MatrixVectorWriter
Constructor for MatrixVectorWriter
MatrixVectorWriter(OutputStream, boolean) - Constructor for class cern.colt.matrix.io.MatrixVectorWriter
Constructor for MatrixVectorWriter
MatrixVectorWriter(Writer) - Constructor for class cern.colt.matrix.io.MatrixVectorWriter
Constructor for MatrixVectorWriter
MatrixVectorWriter(Writer, boolean) - Constructor for class cern.colt.matrix.io.MatrixVectorWriter
Constructor for MatrixVectorWriter
MatrixVisitorException - Exception in org.apache.commons.math.linear
Thrown when a visitor encounters an error while processing a matrix entry.
MatrixVisitorException(String, Object[]) - Constructor for exception org.apache.commons.math.linear.MatrixVisitorException
Constructs a new instance with specified formatted detail message.
MatrixVisitorException(Localizable, Object[]) - Constructor for exception org.apache.commons.math.linear.MatrixVisitorException
Constructs a new instance with specified formatted detail message.
matTwoPowModM(double[][], double[][], double, int) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Computes A2e mod m and puts the result in B.
matTwoPowModM(int[][], int[][], int, int) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Exactly like matTwoPowModM using double, but with int instead of double.
matTwoPowModM(long[][], long[][], long, int) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Exactly like matTwoPowModM using double, but with long instead of double.
matVecModM(double[][], double[], double[], double) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Computes the result of A×s mod m and puts the result in v.
matVecModM(int[][], int[], int[], int) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Exactly like matVecModM using double, but with int instead of double.
matVecModM(long[][], long[], long[], long) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Exactly like matVecModM using double, but with long instead of double.
maundyThursday() - Method in class flanagan.math.TimeAndDate
 
maundyThursday(int) - Method in class flanagan.math.TimeAndDate
 
max() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the maximum.
max - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.max().
max() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the maximum.
max() - Method in class cern.hep.aida.bin.StaticBin1D
Returns the maximum.
max - Static variable in class cern.jet.math.Functions
Function that returns Math.max(a,b).
max(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns Math.max(a,b).
max - Static variable in class cern.jet.math.IntFunctions
Function that returns Math.max(a,b).
max(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns Math.max(a,b).
max - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.max(a,b).
max(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns Math.max(a,b).
max - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.max(a,b).
max(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns Math.max(a,b).
max - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns Math.max(a,b).
max(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns Math.max(a,b).
max - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns Math.max(a,b).
max(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns Math.max(a,b).
max(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the largest member of a data sequence.
max(DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the largest member of a data sequence.
max(FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the largest member of a data sequence.
max() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns the maximum.
max - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.max().
max() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the maximum.
max() - Method in class hep.aida.tdouble.bin.StaticDoubleBin1D
Returns the maximum.
max() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns the maximum.
max() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the maximum.
max - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.max().
max() - Method in class hep.aida.tfloat.bin.StaticFloatBin1D
Returns the maximum.
max(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the maximum of an array.
max(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns the maximum of an array.
max(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the maximum of an array.
max(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns the maximum of an array.
max(double[][]) - Static method in class jhplot.math.DoubleArray
Finds the maximum value in each column of a matrix.
max(double...) - Static method in class jhplot.math.DoubleArray
Finds maximum value in either a list of numbers or a single array.
max(int[][]) - Static method in class jhplot.math.IntegerArray
 
max(int...) - Static method in class jhplot.math.IntegerArray
 
Max - Class in org.apache.commons.math.stat.descriptive.rank
Returns the maximum of the available values.
Max() - Constructor for class org.apache.commons.math.stat.descriptive.rank.Max
Create a Max instance
Max(Max) - Constructor for class org.apache.commons.math.stat.descriptive.rank.Max
Copy constructor, creates a new Max identical to the original
max(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the maximum of the entries in the input array, or Double.NaN if the array is empty.
max(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the maximum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
max(int, int) - Static method in class org.apache.commons.math.util.FastMath
Compute the maximum of two values
max(long, long) - Static method in class org.apache.commons.math.util.FastMath
Compute the maximum of two values
max(float, float) - Static method in class org.apache.commons.math.util.FastMath
Compute the maximum of two values
max(double, double) - Static method in class org.apache.commons.math.util.FastMath
Compute the maximum of two values
max() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Returns the largest value taken by the variable since the last initialization of this probe.
MAX_EXP - Static variable in class org.apache.commons.math.dfp.Dfp
The maximum exponent before overflow is signaled and results flushed to infinity
maxBinHeight() - Method in class hep.aida.ref.histogram.Histogram
Get the maximum height of in-range bins in the Histogram.
maxBinHeight() - Method in class hep.aida.ref.histogram.Histogram1D
Get the maximum height of in-range bins in the Histogram.
maxBinHeight() - Method in class hep.aida.ref.histogram.Histogram2D
Get the maximum height of in-range bins in the Histogram.
maxBinHeight() - Method in class hep.aida.ref.histogram.Histogram3D
Get the maximum height of in-range bins in the Histogram.
maxBinHeight() - Method in class hep.aida.ref.histogram.Profile1D
 
maxBinHeight() - Method in class hep.aida.ref.histogram.Profile2D
 
maxBinHeight() - Method in class jhplot.H1D
Max value of all bins
maxBinHeight() - Method in class jhplot.HProf1D
Max value of all bins
maxEntries() - Method in class hep.aida.ref.histogram.Cloud
Get the maximum number of entries after which the Cloud will convert to an Histogram.
MaxEvaluationsExceededException - Exception in org.apache.commons.math
Error thrown when a numerical computation exceeds its allowed number of functions evaluations.
MaxEvaluationsExceededException(int) - Constructor for exception org.apache.commons.math.MaxEvaluationsExceededException
Constructs an exception with a default detail message.
MaxEvaluationsExceededException(int, String, Object...) - Constructor for exception org.apache.commons.math.MaxEvaluationsExceededException
Deprecated. as of 2.2 replaced by MaxEvaluationsExceededException.MaxEvaluationsExceededException(int, Localizable, Object...)
MaxEvaluationsExceededException(int, Localizable, Object...) - Constructor for exception org.apache.commons.math.MaxEvaluationsExceededException
Constructs an exception with specified formatted detail message.
maximalGumbelArray(double, double, int) - Method in class flanagan.math.PsRandom
 
Maximisation - Class in flanagan.math
 
Maximisation() - Constructor for class flanagan.math.Maximisation
 
MaximisationFunction - Interface in flanagan.math
 
Maximization - Class in flanagan.math
 
Maximization() - Constructor for class flanagan.math.Maximization
 
MaximizationFunction - Interface in flanagan.math
 
MAXIMUM - Static variable in class cern.colt.matrix.doublealgo.Statistic
Maximum distance function; Max( abs(x[i]-y[i]) ).
MAXIMUM - Static variable in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Maximum distance function; Max( abs(x[i]-y[i]) ).
MAXIMUM - Static variable in class cern.colt.matrix.tfloat.algo.FloatStatistic
Maximum distance function; Max( abs(x[i]-y[i]) ).
maximum() - Method in class flanagan.analysis.ProbabilityPlot
 
maximum() - Method in class flanagan.math.ArrayMaths
 
maximum(double[]) - Static method in class flanagan.math.Fmath
 
maximum(float[]) - Static method in class flanagan.math.Fmath
 
maximum(int[]) - Static method in class flanagan.math.Fmath
 
maximum(long[]) - Static method in class flanagan.math.Fmath
 
maximum() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
maximum() - Method in class hep.aida.ref.tuple.TupleColumn
 
maximum_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
maximum_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
maximum_as_byte() - Method in class flanagan.math.ArrayMaths
 
maximum_as_Byte() - Method in class flanagan.math.ArrayMaths
 
maximum_as_char() - Method in class flanagan.math.ArrayMaths
 
maximum_as_Character() - Method in class flanagan.math.ArrayMaths
 
maximum_as_double() - Method in class flanagan.math.ArrayMaths
 
maximum_as_Double() - Method in class flanagan.math.ArrayMaths
 
maximum_as_Float() - Method in class flanagan.math.ArrayMaths
 
maximum_as_float() - Method in class flanagan.math.ArrayMaths
 
maximum_as_int() - Method in class flanagan.math.ArrayMaths
 
maximum_as_Integer() - Method in class flanagan.math.ArrayMaths
 
maximum_as_long() - Method in class flanagan.math.ArrayMaths
 
maximum_as_Long() - Method in class flanagan.math.ArrayMaths
 
maximum_as_short() - Method in class flanagan.math.ArrayMaths
 
maximum_as_Short() - Method in class flanagan.math.ArrayMaths
 
maximumDifference() - Method in class flanagan.math.ArrayMaths
 
maximumDifference(double[]) - Static method in class flanagan.math.Fmath
 
maximumDifference(float[]) - Static method in class flanagan.math.Fmath
 
maximumDifference(long[]) - Static method in class flanagan.math.Fmath
 
maximumDifference(int[]) - Static method in class flanagan.math.Fmath
 
maximumDifference_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_byte() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_Byte() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_double() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_Double() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_float() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_Float() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_int() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_Integer() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_long() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_Long() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_short() - Method in class flanagan.math.ArrayMaths
 
maximumDifference_as_Short() - Method in class flanagan.math.ArrayMaths
 
maximumElement() - Method in class flanagan.math.Matrix
 
maximumIndex() - Method in class flanagan.math.ArrayMaths
 
maxIndex(double[]) - Static method in class jhplot.math.ArrayMathUtils
returns the index of the greatest element from the given array
maxIndex(double[][]) - Static method in class jhplot.math.DoubleArray
Finds the indices of the minimum values in each column of a matrix.
maxIndex(double...) - Static method in class jhplot.math.DoubleArray
Finds the index of the maximum value in a list of values or an array.
maxIndex(int[][]) - Static method in class jhplot.math.IntegerArray
 
maxIndex(int...) - Static method in class jhplot.math.IntegerArray
 
MAXINTDOUBLE - Static variable in class umontreal.iro.lecuyer.util.Num
Largest integer n0 = 253 such that any integer n <= n0 is represented exactly as a double.
MaxIterationsExceededException - Exception in org.apache.commons.math
Error thrown when a numerical computation exceeds its allowed number of iterations.
MaxIterationsExceededException(int) - Constructor for exception org.apache.commons.math.MaxIterationsExceededException
Constructs an exception with a default detail message.
MaxIterationsExceededException(int, String, Object...) - Constructor for exception org.apache.commons.math.MaxIterationsExceededException
Deprecated. as of 2.2 replaced by MaxIterationsExceededException.MaxIterationsExceededException(int, Localizable, Object...)
MaxIterationsExceededException(int, Localizable, Object...) - Constructor for exception org.apache.commons.math.MaxIterationsExceededException
Constructs an exception with specified formatted detail message.
MAXLAMBDA - Static variable in class umontreal.iro.lecuyer.probdist.PoissonDist
 
MAXN - Static variable in class umontreal.iro.lecuyer.probdist.BinomialDist
 
MAXN - Static variable in class umontreal.iro.lecuyer.probdist.HypergeometricDist
 
MAXN - Static variable in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
 
maxScale - Variable in class jhplot.v3d.Model3d
 
MAXTWOEXP - Static variable in class umontreal.iro.lecuyer.util.Num
Powers of 2 up to MAXTWOEXP are stored exactly in the array TWOEXP.
maxValue(Value) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
maxValue(Value) - Method in interface hep.aida.ref.tuple.FTupleColumn
 
maxValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn
 
mcMullenValues() - Method in class flanagan.analysis.RankAnalysis
 
MD5 - Class in jhplot.security
Get MD5 hash for any object or a file with data
MD5(Object) - Constructor for class jhplot.security.MD5
Initialize MD5 calculations
MD5(File) - Constructor for class jhplot.security.MD5
Initialize MD5 calculations for a file
MD5(String) - Static method in class jhplot.security.SimpleMD5
 
mdfft(Object, boolean) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Performs a multi-dimensional Fourier transform on a given array.
mean() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the arithmetic mean, which is Sum( x[i] ) / size().
mean - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.mean().
mean() - Method in class cern.hep.aida.ref.Histogram1D
 
mean(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the arithmetic mean of a data sequence; That is Sum( data[i] ) / data.size().
mean(DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the arithmetic mean of a data sequence; That is Sum( data[i] ) / data.size().
mean(FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the arithmetic mean of a data sequence; That is Sum( data[i] ) / data.size().
mean() - Method in class flanagan.analysis.ProbabilityPlot
 
mean() - Method in class flanagan.analysis.Stat
 
mean(double[]) - Static method in class flanagan.analysis.Stat
 
mean(float[]) - Static method in class flanagan.analysis.Stat
 
mean(long[]) - Static method in class flanagan.analysis.Stat
 
mean(int[]) - Static method in class flanagan.analysis.Stat
 
mean(short[]) - Static method in class flanagan.analysis.Stat
 
mean(byte[]) - Static method in class flanagan.analysis.Stat
 
mean(Complex[]) - Static method in class flanagan.analysis.Stat
 
mean(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
mean(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
mean(double[], double[]) - Static method in class flanagan.analysis.Stat
 
mean(float[], float[]) - Static method in class flanagan.analysis.Stat
 
mean(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
mean(BigDecimal[], BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
mean(BigInteger[], BigInteger[]) - Static method in class flanagan.analysis.Stat
 
mean() - Method in class flanagan.math.Matrix
 
mean(int[], int) - Method in interface hep.aida.ref.dataset.binner.Binner
Get the mean of a bin along a given coordinate.
mean(int[], int) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Get the mean of a bin along a given coordinate.
mean(int) - Method in class hep.aida.ref.dataset.DataStatistics
Get the mean for a given coordinate.
mean(int) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
mean(int) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
mean() - Method in class hep.aida.ref.histogram.Cloud1D
Get the Cloud's mean.
mean() - Method in class hep.aida.ref.histogram.Histogram1D
Get the mean of the whole Histogram.
mean() - Method in class hep.aida.ref.histogram.Profile1D
 
mean() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
mean() - Method in class hep.aida.ref.tuple.TupleColumn
 
mean() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns the arithmetic mean, which is Sum( x[i] ) / size().
mean - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.mean().
mean() - Method in interface hep.aida.tdouble.DoubleIHistogram1D
Returns the mean of the whole histogram as calculated on filling-time.
mean() - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
mean() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns the arithmetic mean, which is Sum( x[i] ) / size().
mean - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.mean().
mean() - Method in interface hep.aida.tfloat.FloatIHistogram1D
Returns the mean of the whole histogram as calculated on filling-time.
mean() - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
mean() - Method in class jhplot.H1D
Get mean of the histogram
mean() - Method in class jhplot.HProf1D
Get mean of the histogram
mean(double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the mean.
mean(int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the mean.
mean(double[]) - Static method in class jhplot.math.StatisticSample
Get mean value
mean(double[][]) - Static method in class jhplot.math.StatisticSample
Get mean
mean() - Method in class jhplot.P0D
Returns the mean value.
mean() - Method in class jhplot.P0I
Returns the mean value.
mean() - Method in class jhplot.P1D
Return the mean value
mean(int) - Method in class jhplot.P2D
Returns the mean value for any axis
mean(double[]) - Static method in class jhplot.stat.Statistics
Get mean value
mean(double[][]) - Static method in class jhplot.stat.Statistics
Get mean
Mean - Class in org.apache.commons.math.stat.descriptive.moment
Computes the arithmetic mean of a set of values.
Mean() - Constructor for class org.apache.commons.math.stat.descriptive.moment.Mean
Constructs a Mean.
Mean(FirstMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Mean
Constructs a Mean with an External Moment.
Mean(Mean) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Mean
Copy constructor, creates a new Mean identical to the original
mean(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the arithmetic mean of the entries in the input array, or Double.NaN if the array is empty.
mean(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the arithmetic mean of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
MEAN - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Mean
mean_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
mean_as_Complex() - Method in class flanagan.analysis.Stat
 
mean_as_double() - Method in class flanagan.analysis.Stat
 
meanDeviation(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the mean deviation of a dataset.
meanDeviation(DoubleArrayList, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the mean deviation of a dataset.
meanDeviation(FloatArrayList, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the mean deviation of a dataset.
meanDifference(double[], double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the mean of the (signed) differences between corresponding elements of the input arrays -- i.e., sum(sample1[i] - sample2[i]) / sample1.length.
meanValue(Value) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
meanValue(Value) - Method in interface hep.aida.ref.tuple.FTupleColumn
 
meanValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn
 
meanX() - Method in class cern.hep.aida.ref.Histogram2D
 
meanX() - Method in class cern.hep.aida.ref.Histogram3D
 
meanX(int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
meanX(int, int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
meanX(int, int) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
meanX(int, int, int) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
meanX(int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
meanX(int, int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
meanX() - Method in class hep.aida.ref.histogram.Cloud2D
Get the Cloud's x mean.
meanX() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's x mean.
meanX() - Method in class hep.aida.ref.histogram.Histogram2D
Get the mean of the whole Histogram as projected on the x axis.
meanX() - Method in class hep.aida.ref.histogram.Histogram3D
Get the mean of the whole Histogram as projected on the x axis.
meanX() - Method in class hep.aida.ref.histogram.Profile2D
 
meanX() - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Returns the mean of the histogram, as calculated on filling-time projected on the X axis.
meanX() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Returns the mean of the histogram, as calculated on filling-time projected on the X axis.
meanX() - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
meanX() - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
meanX() - Method in interface hep.aida.tfloat.FloatIHistogram2D
Returns the mean of the histogram, as calculated on filling-time projected on the X axis.
meanX() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Returns the mean of the histogram, as calculated on filling-time projected on the X axis.
meanX() - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
meanX() - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
meanX() - Method in class jhplot.P1D
Returns the mean value in X.
meanX() - Method in class jhplot.P2D
Returns the mean value in X.
meanX() - Method in class jhplot.P3D
Returns the mean value in X.
meanXerror() - Method in class jhplot.P1D
Returns the standard error of the mean values for X.
meanY() - Method in class cern.hep.aida.ref.Histogram2D
 
meanY() - Method in class cern.hep.aida.ref.Histogram3D
 
meanY(int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
meanY(int, int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
meanY(int, int) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
meanY(int, int, int) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
meanY(int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
meanY(int, int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
meanY() - Method in class hep.aida.ref.histogram.Cloud2D
Get the Cloud's y mean.
meanY() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's y mean.
meanY() - Method in class hep.aida.ref.histogram.Histogram2D
Get the mean of the whole Histogram as projected on the y axis.
meanY() - Method in class hep.aida.ref.histogram.Histogram3D
Get the mean of the whole Histogram as projected on the y axis.
meanY() - Method in class hep.aida.ref.histogram.Profile2D
 
meanY() - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Returns the mean of the histogram, as calculated on filling-time projected on the Y axis.
meanY() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Returns the mean of the histogram, as calculated on filling-time projected on the Y axis.
meanY() - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
meanY() - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
meanY() - Method in interface hep.aida.tfloat.FloatIHistogram2D
Returns the mean of the histogram, as calculated on filling-time projected on the Y axis.
meanY() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Returns the mean of the histogram, as calculated on filling-time projected on the Y axis.
meanY() - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
meanY() - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
meanY() - Method in class jhplot.P1D
Returns the mean value in Y.
meanY() - Method in class jhplot.P2D
Returns the mean value in Y.
meanY() - Method in class jhplot.P3D
Returns the mean value in Y.
meanYerror() - Method in class jhplot.P1D
Returns the standard error of the mean values for Y.
meanZ() - Method in class cern.hep.aida.ref.Histogram3D
 
meanZ(int, int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
meanZ(int, int, int) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
meanZ(int, int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
meanZ() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's z mean.
meanZ() - Method in class hep.aida.ref.histogram.Histogram3D
Get the mean of the whole Histogram as projected on the z axis.
meanZ() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Returns the mean of the histogram, as calculated on filling-time projected on the Z axis.
meanZ() - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
meanZ() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Returns the mean of the histogram, as calculated on filling-time projected on the Z axis.
meanZ() - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
meanZ() - Method in class jhplot.P2D
Returns the mean value in Z.
meanZ() - Method in class jhplot.P3D
Returns the mean value in Z.
Measurement - Class in hep.aida.ref.histogram
Basic user-level interface class for holding a single "measurement" with positive and negative errors (to allow for asymmetric errors).
Measurement() - Constructor for class hep.aida.ref.histogram.Measurement
 
Measurement(IMeasurement) - Constructor for class hep.aida.ref.histogram.Measurement
 
Measurement(double) - Constructor for class hep.aida.ref.histogram.Measurement
 
Measurement(double, double) - Constructor for class hep.aida.ref.histogram.Measurement
 
Measurement(double, double, double) - Constructor for class hep.aida.ref.histogram.Measurement
 
median - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.median().
median() - Method in class cern.hep.aida.bin.QuantileBin1D
Returns the median.
median(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the median of a sorted data sequence.
median(DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the median of a sorted data sequence.
median(FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the median of a sorted data sequence.
median() - Method in class flanagan.analysis.Stat
 
median(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
median(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
median(double[]) - Static method in class flanagan.analysis.Stat
 
median(float[]) - Static method in class flanagan.analysis.Stat
 
median(int[]) - Static method in class flanagan.analysis.Stat
 
median(long[]) - Static method in class flanagan.analysis.Stat
 
median() - Method in class flanagan.math.Matrix
 
median - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.median().
median() - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Returns the median.
median - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.median().
median() - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Returns the median.
median(double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the median of an array.
median(int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the median of an array.
median() - Method in class jhplot.P0D
Returns the median.
median() - Method in class jhplot.P0I
Returns the median.
Median - Class in org.apache.commons.math.stat.descriptive.rank
Returns the median of the available values.
Median() - Constructor for class org.apache.commons.math.stat.descriptive.rank.Median
Default constructor.
Median(Median) - Constructor for class org.apache.commons.math.stat.descriptive.rank.Median
Copy constructor, creates a new Median identical to the original
median_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
median_as_double() - Method in class flanagan.analysis.Stat
 
medianSkewness() - Method in class flanagan.analysis.Stat
 
medianSkewness(double[]) - Static method in class flanagan.analysis.Stat
 
medianSkewness(float[]) - Static method in class flanagan.analysis.Stat
 
medianSkewness(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
medianSkewness(long[]) - Static method in class flanagan.analysis.Stat
 
medianSkewness(int[]) - Static method in class flanagan.analysis.Stat
 
medianSkewness_as_double() - Method in class flanagan.analysis.Stat
 
megaelectronvolt - Static variable in class cern.clhep.Units
 
megahertz - Static variable in class cern.clhep.Units
 
megavolt - Static variable in class cern.clhep.Units
 
memory() - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Returns the number of elements currently needed to store all contained elements.
memory() - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Returns the number of elements currently needed to store all contained elements.
memory() - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Returns the number of elements currently needed to store all contained elements.
memory() - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Returns the number of elements currently needed to store all contained elements.
memory() - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Returns the number of elements currently needed to store all contained elements.
merge(double[]...) - Static method in class jhplot.math.DoubleArray
Concatenates arrays.
merge(int[]...) - Static method in class jhplot.math.IntegerArray
 
merge(P0D) - Method in class jhplot.P0D
Merge two P0D containers
merge(P0I) - Method in class jhplot.P0I
Merge two P0I containers
merge(P1D) - Method in class jhplot.P1D
Merge two P1D containers.
merge(P2D) - Method in class jhplot.P2D
Merge two P2D containers
merge(P3D) - Method in class jhplot.P3D
Merge two P3D containers
mergeColumns(double[]...) - Static method in class jhplot.math.DoubleArray
Combine a set of arrays into a matrix.
mergeColumns(int[]...) - Static method in class jhplot.math.IntegerArray
 
mergeRows(double[]...) - Static method in class jhplot.math.DoubleArray
Combine a set of arrays into a matrix.
mergeRows(int[]...) - Static method in class jhplot.math.IntegerArray
 
mergeSort(int, int, IntComparator, Swapper) - Static method in class cern.colt.GenericSorting
Sorts the specified range of elements according to the order induced by the specified comparator.
mergeSort() - Method in class cern.colt.list.AbstractList
Sorts the receiver into ascending order.
mergeSort - Static variable in class cern.colt.matrix.doublealgo.Sorting
A prefabricated mergesort.
mergeSort - Static variable in class cern.colt.matrix.objectalgo.Sorting
A prefabricated mergesort.
mergeSort - Static variable in class cern.colt.matrix.tdouble.algo.DoubleSorting
A prefabricated mergesort.
mergeSort - Static variable in class cern.colt.matrix.tfloat.algo.FloatSorting
A prefabricated mergesort.
mergeSort - Static variable in class cern.colt.matrix.tint.algo.IntSorting
A prefabricated mergesort.
mergeSort - Static variable in class cern.colt.matrix.tlong.algo.LongSorting
A prefabricated mergesort.
mergeSort - Static variable in class cern.colt.matrix.tobject.algo.ObjectSorting
A prefabricated mergesort.
mergeSort(byte[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(byte[], int, int, ByteComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(char[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(char[], int, int, CharComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(double[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(double[], int, int, DoubleComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(float[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(float[], int, int, FloatComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(int[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(int[], int, int, IntComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(long[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(long[], int, int, LongComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSort(short[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
mergeSort(short[], int, int, ShortComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractByteList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, ByteComparator) - Method in class cern.colt.list.AbstractByteList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractCharList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, CharComparator) - Method in class cern.colt.list.AbstractCharList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractDoubleList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, DoubleComparator) - Method in class cern.colt.list.AbstractDoubleList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractFloatList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, FloatComparator) - Method in class cern.colt.list.AbstractFloatList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractIntList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, IntComparator) - Method in class cern.colt.list.AbstractIntList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractList
Sorts the receiver into ascending order.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractLongList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, LongComparator) - Method in class cern.colt.list.AbstractLongList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.AbstractShortList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, ShortComparator) - Method in class cern.colt.list.AbstractShortList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Sorts the specified range of the receiver into ascending order (false < true).
mergeSortFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Sorts the specified range of the receiver into ascending order, according to the natural ordering of its elements.
mergeSortFromTo(int, int, Comparator) - Method in class cern.colt.list.ObjectArrayList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Sorts the specified range of the receiver into ascending order ( false < true).
mergeSortFromTo(int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, ByteComparator) - Method in class cern.colt.list.tbyte.AbstractByteList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, CharComparator) - Method in class cern.colt.list.tchar.AbstractCharList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, DoubleComparator) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, FloatComparator) - Method in class cern.colt.list.tfloat.AbstractFloatList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.tint.AbstractIntList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, IntComparator) - Method in class cern.colt.list.tint.AbstractIntList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, LongComparator) - Method in class cern.colt.list.tlong.AbstractLongList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Sorts the specified range of the receiver into ascending order, according to the natural ordering of its elements.
mergeSortFromTo(int, int, Comparator) - Method in class cern.colt.list.tobject.ObjectArrayList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortFromTo(int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Sorts the specified range of the receiver into ascending order.
mergeSortFromTo(int, int, ShortComparator) - Method in class cern.colt.list.tshort.AbstractShortList
Sorts the receiver according to the order induced by the specified comparator.
mergeSortInPlace(int[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements.
MersenneTwister - Class in cern.jet.random.engine
MersenneTwister (MT19937) is one of the strongest uniform pseudo-random number generators known so far; at the same time it is quick.
MersenneTwister() - Constructor for class cern.jet.random.engine.MersenneTwister
Constructs and returns a random number generator with a default seed, which is a constant.
MersenneTwister(int) - Constructor for class cern.jet.random.engine.MersenneTwister
Constructs and returns a random number generator with the given seed.
MersenneTwister(Date) - Constructor for class cern.jet.random.engine.MersenneTwister
Constructs and returns a random number generator seeded with the given date.
MersenneTwister - Class in org.apache.commons.math.random
This class implements a powerful pseudo-random number generator developed by Makoto Matsumoto and Takuji Nishimura during 1996-1997.
MersenneTwister() - Constructor for class org.apache.commons.math.random.MersenneTwister
Creates a new random number generator.
MersenneTwister(int) - Constructor for class org.apache.commons.math.random.MersenneTwister
Creates a new random number generator using a single int seed.
MersenneTwister(int[]) - Constructor for class org.apache.commons.math.random.MersenneTwister
Creates a new random number generator using an int array seed.
MersenneTwister(long) - Constructor for class org.apache.commons.math.random.MersenneTwister
Creates a new random number generator using a single long seed.
MersenneTwister64 - Class in cern.jet.random.engine
Same as MersenneTwister except that method raw() returns 64 bit random numbers instead of 32 bit random numbers.
MersenneTwister64() - Constructor for class cern.jet.random.engine.MersenneTwister64
Constructs and returns a random number generator with a default seed, which is a constant.
MersenneTwister64(int) - Constructor for class cern.jet.random.engine.MersenneTwister64
Constructs and returns a random number generator with the given seed.
MersenneTwister64(Date) - Constructor for class cern.jet.random.engine.MersenneTwister64
Constructs and returns a random number generator seeded with the given date.
MersenneTwister64 - Class in cern.jet.random.tdouble.engine
Same as MersenneTwister except that method raw() returns 64 bit random numbers instead of 32 bit random numbers.
MersenneTwister64() - Constructor for class cern.jet.random.tdouble.engine.MersenneTwister64
Constructs and returns a random number generator with a default seed, which is a constant.
MersenneTwister64(int) - Constructor for class cern.jet.random.tdouble.engine.MersenneTwister64
Constructs and returns a random number generator with the given seed.
MersenneTwister64(Date) - Constructor for class cern.jet.random.tdouble.engine.MersenneTwister64
Constructs and returns a random number generator seeded with the given date.
MessageFactory - Class in org.apache.commons.math.exception.util
Class for constructing localized messages.
meter - Static variable in class cern.clhep.Units
 
meter2 - Static variable in class cern.clhep.Units
 
meter3 - Static variable in class cern.clhep.Units
 
metreToFoot(double) - Static method in class flanagan.math.Conv
 
metreToFoot(double) - Static method in class flanagan.math.Fmath
 
metreToYard(double) - Static method in class flanagan.math.Conv
 
metreToYard(double) - Static method in class flanagan.math.Fmath
 
metropolis(double[], F1D, double) - Static method in class jhplot.math.Numeric
The Metropolis algorithm.
MeV - Static variable in class cern.clhep.Units
 
mg - Static variable in class cern.clhep.Units
 
microampere - Static variable in class cern.clhep.Units
 
microbarn - Static variable in class cern.clhep.Units
 
microfarad - Static variable in class cern.clhep.Units
 
micrometer - Static variable in class cern.clhep.Units
 
microsecond - Static variable in class cern.clhep.Units
 
MicrosphereInterpolatingFunction - Class in org.apache.commons.math.analysis.interpolation
Interpolating function that implements the Microsphere Projection.
MicrosphereInterpolatingFunction(double[][], double[], int, int, UnitSphereRandomVectorGenerator) - Constructor for class org.apache.commons.math.analysis.interpolation.MicrosphereInterpolatingFunction
 
MicrosphereInterpolator - Class in org.apache.commons.math.analysis.interpolation
Interpolator that implements the algorithm described in William Dudziak's MS thesis.
MicrosphereInterpolator() - Constructor for class org.apache.commons.math.analysis.interpolation.MicrosphereInterpolator
Create a microsphere interpolator with default settings.
MicrosphereInterpolator(int, int) - Constructor for class org.apache.commons.math.analysis.interpolation.MicrosphereInterpolator
Create a microsphere interpolator.
midpoint(double, double) - Static method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverUtils
Compute the midpoint of two values.
MidpointIntegrator - Class in org.apache.commons.math.ode.nonstiff
This class implements a second order Runge-Kutta integrator for Ordinary Differential Equations.
MidpointIntegrator(double) - Constructor for class org.apache.commons.math.ode.nonstiff.MidpointIntegrator
Simple constructor.
MightyStaticBin1D - Class in cern.hep.aida.bin
Static and the same as its superclass, except that it can do more: Additionally computes moments of arbitrary integer order, harmonic mean, geometric mean, etc.
MightyStaticBin1D() - Constructor for class cern.hep.aida.bin.MightyStaticBin1D
Constructs and returns an empty bin with limited functionality but good performance; equivalent to MightyStaticBin1D(false,false,4).
MightyStaticBin1D(boolean, boolean, int) - Constructor for class cern.hep.aida.bin.MightyStaticBin1D
Constructs and returns an empty bin with the given capabilities.
MightyStaticDoubleBin1D - Class in hep.aida.tdouble.bin
Static and the same as its superclass, except that it can do more: Additionally computes moments of arbitrary integer order, harmonic mean, geometric mean, etc.
MightyStaticDoubleBin1D() - Constructor for class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Constructs and returns an empty bin with limited functionality but good performance; equivalent to MightyStaticBin1D(false,false,4).
MightyStaticDoubleBin1D(boolean, boolean, int) - Constructor for class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Constructs and returns an empty bin with the given capabilities.
MightyStaticFloatBin1D - Class in hep.aida.tfloat.bin
Static and the same as its superclass, except that it can do more: Additionally computes moments of arbitrary integer order, harmonic mean, geometric mean, etc.
MightyStaticFloatBin1D() - Constructor for class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Constructs and returns an empty bin with limited functionality but good performance; equivalent to MightyStaticBin1D(false,false,4).
MightyStaticFloatBin1D(boolean, boolean, int) - Constructor for class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Constructs and returns an empty bin with the given capabilities.
milePerGallonToKmPerLitre(double) - Static method in class flanagan.math.Conv
 
milePerGallonToKmPerLitre(double) - Static method in class flanagan.math.Fmath
 
mileToKm(double) - Static method in class flanagan.math.Conv
 
mileToKm(double) - Static method in class flanagan.math.Fmath
 
milliampere - Static variable in class cern.clhep.Units
 
millibarn - Static variable in class cern.clhep.Units
 
millifarad - Static variable in class cern.clhep.Units
 
milligram - Static variable in class cern.clhep.Units
 
millimeter - Static variable in class cern.clhep.Units
 
millimeter2 - Static variable in class cern.clhep.Units
 
millimeter3 - Static variable in class cern.clhep.Units
 
millimetreToInch(double) - Static method in class flanagan.math.Conv
 
millimetreToInch(double) - Static method in class flanagan.math.Fmath
 
milliradian - Static variable in class cern.clhep.Units
 
millis() - Method in class cern.colt.Timer
Returns the elapsed time in milli seconds; does not stop the timer, if started.
millisecond - Static variable in class cern.clhep.Units
 
min() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the minimum.
min - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.min().
min() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the minimum.
min() - Method in class cern.hep.aida.bin.StaticBin1D
Returns the minimum.
min - Static variable in class cern.jet.math.Functions
Function that returns Math.min(a,b).
min(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns Math.min(a,b).
min - Static variable in class cern.jet.math.IntFunctions
Function that returns Math.min(a,b).
min(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns Math.min(a,b).
min - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.min(a,b).
min(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns Math.min(a,b).
min - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.min(a,b).
min(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns Math.min(a,b).
min - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns Math.min(a,b).
min(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns Math.min(a,b).
min - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns Math.min(a,b).
min(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns Math.min(a,b).
min(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the smallest member of a data sequence.
min(DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the smallest member of a data sequence.
min(FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the smallest member of a data sequence.
min() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns the minimum.
min - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.min().
min() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the minimum.
min() - Method in class hep.aida.tdouble.bin.StaticDoubleBin1D
Returns the minimum.
min() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns the minimum.
min() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the minimum.
min - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.min().
min() - Method in class hep.aida.tfloat.bin.StaticFloatBin1D
Returns the minimum.
min(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the minimum of an array.
min(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns the minimum of an array.
min(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the minimum of an array.
min(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns the minimum of an array.
min(double[][]) - Static method in class jhplot.math.DoubleArray
Finds the minimum value in each column of a matrix.
min(double...) - Static method in class jhplot.math.DoubleArray
Finds minimum value in either a list of numbers or a single array.
min(int[][]) - Static method in class jhplot.math.IntegerArray
 
min(int...) - Static method in class jhplot.math.IntegerArray
 
Min - Class in org.apache.commons.math.stat.descriptive.rank
Returns the minimum of the available values.
Min() - Constructor for class org.apache.commons.math.stat.descriptive.rank.Min
Create a Min instance
Min(Min) - Constructor for class org.apache.commons.math.stat.descriptive.rank.Min
Copy constructor, creates a new Min identical to the original
min(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the minimum of the entries in the input array, or Double.NaN if the array is empty.
min(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the minimum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
min(int, int) - Static method in class org.apache.commons.math.util.FastMath
Compute the minimum of two values
min(long, long) - Static method in class org.apache.commons.math.util.FastMath
Compute the minimum of two values
min(float, float) - Static method in class org.apache.commons.math.util.FastMath
Compute the minimum of two values
min(double, double) - Static method in class org.apache.commons.math.util.FastMath
Compute the minimum of two values
min() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Returns the smallest value taken by the variable since the last initialization of this probe.
MIN_EXP - Static variable in class org.apache.commons.math.dfp.Dfp
The minimum exponent before underflow is signaled.
minBinHeight() - Method in class hep.aida.ref.histogram.Histogram
Get the minimum height of in-range bins in the Histogram.
minBinHeight() - Method in class hep.aida.ref.histogram.Histogram1D
Get the minimum height of in-range bins in the Histogram.
minBinHeight() - Method in class hep.aida.ref.histogram.Histogram2D
Get the minimum height of in-range bins in the Histogram.
minBinHeight() - Method in class hep.aida.ref.histogram.Histogram3D
Get the minimum height of in-range bins in the Histogram.
minBinHeight() - Method in class hep.aida.ref.histogram.Profile1D
 
minBinHeight() - Method in class hep.aida.ref.histogram.Profile2D
 
minBinHeight() - Method in class jhplot.H1D
Min value of all bins
minBinHeight() - Method in class jhplot.HProf1D
Min value of all bins
minimalGumbelArray(double, double, int) - Method in class flanagan.math.PsRandom
 
Minimisation - Class in flanagan.math
 
Minimisation() - Constructor for class flanagan.math.Minimisation
 
MinimisationFunction - Interface in flanagan.math
 
Minimization - Class in flanagan.math
 
Minimization() - Constructor for class flanagan.math.Minimization
 
MinimizationFunction - Interface in flanagan.math
 
minimum() - Method in class flanagan.analysis.ProbabilityPlot
 
minimum() - Method in class flanagan.math.ArrayMaths
 
minimum(double[]) - Static method in class flanagan.math.Fmath
 
minimum(float[]) - Static method in class flanagan.math.Fmath
 
minimum(int[]) - Static method in class flanagan.math.Fmath
 
minimum(long[]) - Static method in class flanagan.math.Fmath
 
minimum() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
minimum() - Method in class hep.aida.ref.tuple.TupleColumn
 
minimum_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
minimum_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
minimum_as_byte() - Method in class flanagan.math.ArrayMaths
 
minimum_as_Byte() - Method in class flanagan.math.ArrayMaths
 
minimum_as_char() - Method in class flanagan.math.ArrayMaths
 
minimum_as_Character() - Method in class flanagan.math.ArrayMaths
 
minimum_as_double() - Method in class flanagan.math.ArrayMaths
 
minimum_as_Double() - Method in class flanagan.math.ArrayMaths
 
minimum_as_Float() - Method in class flanagan.math.ArrayMaths
 
minimum_as_float() - Method in class flanagan.math.ArrayMaths
 
minimum_as_int() - Method in class flanagan.math.ArrayMaths
 
minimum_as_Integer() - Method in class flanagan.math.ArrayMaths
 
minimum_as_long() - Method in class flanagan.math.ArrayMaths
 
minimum_as_Long() - Method in class flanagan.math.ArrayMaths
 
minimum_as_short() - Method in class flanagan.math.ArrayMaths
 
minimum_as_Short() - Method in class flanagan.math.ArrayMaths
 
minimumDifference() - Method in class flanagan.math.ArrayMaths
 
minimumDifference(double[]) - Static method in class flanagan.math.Fmath
 
minimumDifference(float[]) - Static method in class flanagan.math.Fmath
 
minimumDifference(long[]) - Static method in class flanagan.math.Fmath
 
minimumDifference(int[]) - Static method in class flanagan.math.Fmath
 
minimumDifference_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_byte() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_Byte() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_double() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_Double() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_float() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_Float() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_int() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_Integer() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_long() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_Long() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_short() - Method in class flanagan.math.ArrayMaths
 
minimumDifference_as_Short() - Method in class flanagan.math.ArrayMaths
 
minimumElement() - Method in class flanagan.math.Matrix
 
minimumIndex() - Method in class flanagan.math.ArrayMaths
 
minimumSize() - Method in class jhplot.v3d.Canvas3d
 
minIndex(double[]) - Static method in class jhplot.math.ArrayMathUtils
returns the index of the smallest element from the given array
minIndex(double[][]) - Static method in class jhplot.math.DoubleArray
Finds the indices of the minimum values in each column of a matrix.
minIndex(double...) - Static method in class jhplot.math.DoubleArray
Finds the index of the minumum value in a list of values or an array.
minIndex(int[][]) - Static method in class jhplot.math.IntegerArray
 
minIndex(int...) - Static method in class jhplot.math.IntegerArray
 
minMaxBins() - Method in interface hep.aida.tdouble.DoubleIHistogram1D
Indexes of the in-range bins containing the smallest and largest binHeight(), respectively.
minMaxBins() - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Indexes of the in-range bins containing the smallest and largest binHeight(), respectively.
minMaxBins() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Indexes of the in-range bins containing the smallest and largest binHeight(), respectively.
minMaxBins() - Method in interface hep.aida.tfloat.FloatIHistogram1D
Indexes of the in-range bins containing the smallest and largest binHeight(), respectively.
minMaxBins() - Method in interface hep.aida.tfloat.FloatIHistogram2D
Indexes of the in-range bins containing the smallest and largest binHeight(), respectively.
minMaxBins() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Indexes of the in-range bins containing the smallest and largest binHeight(), respectively.
MinMaxNumberList - Class in cern.colt.list
Resizable compressed list holding numbers; based on the fact that a value in a given interval need not take more than log(max-min+1) bits; implemented with a cern.colt.bitvector.BitVector.
MinMaxNumberList(long, long, int) - Constructor for class cern.colt.list.MinMaxNumberList
Constructs an empty list with the specified initial capacity and the specified range of values allowed to be hold in this list.
MinMaxNumberList - Class in cern.colt.list.tlong
Resizable compressed list holding numbers; based on the fact that a value in a given interval need not take more than log(max-min+1) bits; implemented with a cern.colt.bitvector.BitVector.
MinMaxNumberList(long, long, int) - Constructor for class cern.colt.list.tlong.MinMaxNumberList
Constructs an empty list with the specified initial capacity and the specified range of values allowed to be hold in this list.
minScale - Variable in class jhplot.v3d.Model3d
 
minus(DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A - s <=> A[i] = A[i] - s.
minus(DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A - B <=> A[i] = A[i] - B[i].
minus(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A - s <=> A[row,col] = A[row,col] - s.
minus(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A - B <=> A[row,col] = A[row,col] - B[row,col].
minus(Timer) - Method in class cern.colt.Timer
T = this - other; Constructs and returns a new timer which is the difference of the receiver and the other timer.
minus - Static variable in class cern.jet.math.Functions
Function that returns a - b.
minus(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a - b.
minus - Static variable in class cern.jet.math.IntFunctions
Function that returns a - b.
minus(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a - b.
minus(double[], double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
minus - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
minus(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
minus - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a - b.
minus(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a - b.
minus(float[], float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
minus - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
minus(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
minus - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a - b.
minus(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a - b.
minus - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a - b.
minus(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a - b.
minus - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a - b.
minus(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a - b.
minus(ErrorProp, double) - Method in class flanagan.analysis.ErrorProp
 
minus(ErrorProp, ErrorProp, double) - Static method in class flanagan.analysis.ErrorProp
 
minus(ErrorProp) - Method in class flanagan.analysis.ErrorProp
 
minus(ErrorProp, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
minus(double) - Method in class flanagan.analysis.ErrorProp
 
minus(double, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
minus(double, double) - Static method in class flanagan.analysis.ErrorProp
 
minus(double) - Method in class flanagan.analysis.Stat
 
minus(float) - Method in class flanagan.analysis.Stat
 
minus(long) - Method in class flanagan.analysis.Stat
 
minus(int) - Method in class flanagan.analysis.Stat
 
minus(short) - Method in class flanagan.analysis.Stat
 
minus(byte) - Method in class flanagan.analysis.Stat
 
minus(char) - Method in class flanagan.analysis.Stat
 
minus(BigDecimal) - Method in class flanagan.analysis.Stat
 
minus(BigInteger) - Method in class flanagan.analysis.Stat
 
minus(Complex) - Method in class flanagan.analysis.Stat
 
minus(Phasor) - Method in class flanagan.analysis.Stat
 
minus(Double) - Method in class flanagan.analysis.Stat
 
minus(Float) - Method in class flanagan.analysis.Stat
 
minus(Long) - Method in class flanagan.analysis.Stat
 
minus(Integer) - Method in class flanagan.analysis.Stat
 
minus(Short) - Method in class flanagan.analysis.Stat
 
minus(Byte) - Method in class flanagan.analysis.Stat
 
minus(Character) - Method in class flanagan.analysis.Stat
 
minus(Stat) - Method in class flanagan.analysis.Stat
 
minus(ArrayMaths) - Method in class flanagan.analysis.Stat
 
minus(Vector<Object>) - Method in class flanagan.analysis.Stat
 
minus(ArrayList<Object>) - Method in class flanagan.analysis.Stat
 
minus(double[]) - Method in class flanagan.analysis.Stat
 
minus(float[]) - Method in class flanagan.analysis.Stat
 
minus(long[]) - Method in class flanagan.analysis.Stat
 
minus(int[]) - Method in class flanagan.analysis.Stat
 
minus(short[]) - Method in class flanagan.analysis.Stat
 
minus(byte[]) - Method in class flanagan.analysis.Stat
 
minus(BigDecimal[]) - Method in class flanagan.analysis.Stat
 
minus(BigInteger[]) - Method in class flanagan.analysis.Stat
 
minus(Complex[]) - Method in class flanagan.analysis.Stat
 
minus(Phasor[]) - Method in class flanagan.analysis.Stat
 
minus(Double[]) - Method in class flanagan.analysis.Stat
 
minus(Float[]) - Method in class flanagan.analysis.Stat
 
minus(Long[]) - Method in class flanagan.analysis.Stat
 
minus(Integer[]) - Method in class flanagan.analysis.Stat
 
minus(Short[]) - Method in class flanagan.analysis.Stat
 
minus(Byte[]) - Method in class flanagan.analysis.Stat
 
minus(double) - Method in class flanagan.math.ArrayMaths
 
minus(Double) - Method in class flanagan.math.ArrayMaths
 
minus(double[]) - Method in class flanagan.math.ArrayMaths
 
minus(Double[]) - Method in class flanagan.math.ArrayMaths
 
minus(float) - Method in class flanagan.math.ArrayMaths
 
minus(Float) - Method in class flanagan.math.ArrayMaths
 
minus(float[]) - Method in class flanagan.math.ArrayMaths
 
minus(Float[]) - Method in class flanagan.math.ArrayMaths
 
minus(long) - Method in class flanagan.math.ArrayMaths
 
minus(Long) - Method in class flanagan.math.ArrayMaths
 
minus(long[]) - Method in class flanagan.math.ArrayMaths
 
minus(Long[]) - Method in class flanagan.math.ArrayMaths
 
minus(int) - Method in class flanagan.math.ArrayMaths
 
minus(Integer) - Method in class flanagan.math.ArrayMaths
 
minus(int[]) - Method in class flanagan.math.ArrayMaths
 
minus(Integer[]) - Method in class flanagan.math.ArrayMaths
 
minus(short) - Method in class flanagan.math.ArrayMaths
 
minus(Short) - Method in class flanagan.math.ArrayMaths
 
minus(short[]) - Method in class flanagan.math.ArrayMaths
 
minus(Short[]) - Method in class flanagan.math.ArrayMaths
 
minus(BigDecimal) - Method in class flanagan.math.ArrayMaths
 
minus(byte) - Method in class flanagan.math.ArrayMaths
 
minus(Byte) - Method in class flanagan.math.ArrayMaths
 
minus(byte[]) - Method in class flanagan.math.ArrayMaths
 
minus(Byte[]) - Method in class flanagan.math.ArrayMaths
 
minus(BigDecimal[]) - Method in class flanagan.math.ArrayMaths
 
minus(BigInteger) - Method in class flanagan.math.ArrayMaths
 
minus(BigInteger[]) - Method in class flanagan.math.ArrayMaths
 
minus(Complex) - Method in class flanagan.math.ArrayMaths
 
minus(Complex[]) - Method in class flanagan.math.ArrayMaths
 
minus(Phasor) - Method in class flanagan.math.ArrayMaths
 
minus(Phasor[]) - Method in class flanagan.math.ArrayMaths
 
minus(Vector<Object>) - Method in class flanagan.math.ArrayMaths
 
minus(ArrayList<Object>) - Method in class flanagan.math.ArrayMaths
 
minus(ArrayMaths) - Method in class flanagan.math.ArrayMaths
 
minus(Stat) - Method in class flanagan.math.ArrayMaths
 
minus(Matrix) - Method in class flanagan.math.Matrix
 
minus(double[][]) - Method in class flanagan.math.Matrix
 
minus(Matrix, Matrix) - Static method in class flanagan.math.Matrix
 
minus(Complex) - Method in class jhplot.math.Complex
Subtraction of Complex numbers (doesn't change this Complex number).
minus(double[], double[]) - Static method in class jhplot.math.LinearAlgebra
Element-wise subtraction of two arrays.
minus(double[], double) - Static method in class jhplot.math.LinearAlgebra
Subtracts a scalar value from each element of an array
minus(double, double[]) - Static method in class jhplot.math.LinearAlgebra
Subtracts each element of an array from a scalar value.
minus(double[][], double[][]) - Static method in class jhplot.math.LinearAlgebra
Element-wise subtraction of two matrices.
minus(double[][], double) - Static method in class jhplot.math.LinearAlgebra
Subtract a scalar from each element of a matrix.
minus(double, double[][]) - Static method in class jhplot.math.LinearAlgebra
Subtract each element of a matrix from a scalar.
minus(ValueErr, double) - Method in class jhplot.math.ValueErr
Subtract an ValueErr number from this ValueErr number with correlation
minus(ValueErr, ValueErr, double) - Static method in class jhplot.math.ValueErr
Subtract ValueErr number b from ValueErr number a with correlation
minus(ValueErr) - Method in class jhplot.math.ValueErr
Subtract a ValueErr number from this ValueErr number without correlation
minus(ValueErr, ValueErr) - Static method in class jhplot.math.ValueErr
Subtract ValueErr number b from ValueErr number without correlation
minus(double) - Method in class jhplot.math.ValueErr
Subtract an error free double number from this ValueErr number.
minus(double, ValueErr) - Static method in class jhplot.math.ValueErr
Subtract a ValueErr number b from an error free double
minus(double, double) - Static method in class jhplot.math.ValueErr
Subtract an error free double number b from an error free double a and return sum as ValueErr
MINUS_I - Static variable in class org.apache.commons.math.geometry.Vector3D
Opposite of the first canonical vector (coordinates: -1, 0, 0).
MINUS_INF() - Method in class hep.aida.ref.function.RangeSet
 
MINUS_J - Static variable in class org.apache.commons.math.geometry.Vector3D
Opposite of the second canonical vector (coordinates: 0, -1, 0).
MINUS_K - Static variable in class org.apache.commons.math.geometry.Vector3D
Opposite of the third canonical vector (coordinates: 0, 0, -1).
MINUS_ONE - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "-1 / 1".
MINUS_ONE - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "-1 / 1".
minusAbs(double[], double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
minusAbs(float[], float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
minusDiv(double) - Static method in class cern.jet.math.PlusMult
a - b/constant.
minusDiv(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexPlusMultFirst
a - b/constant.
minusDiv(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexPlusMultSecond
a - b/constant.
minusDiv(double) - Static method in class cern.jet.math.tdouble.DoublePlusMultFirst
a - b/constant.
minusDiv(double) - Static method in class cern.jet.math.tdouble.DoublePlusMultSecond
a - b/constant.
minusDiv(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexPlusMultFirst
a - b/constant.
minusDiv(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexPlusMultSecond
a - b/constant.
minusDiv(float) - Static method in class cern.jet.math.tfloat.FloatPlusMultFirst
a/constant - b.
minusDiv(float) - Static method in class cern.jet.math.tfloat.FloatPlusMultSecond
a - b/constant.
minusEquals(ErrorProp, double) - Method in class flanagan.analysis.ErrorProp
 
minusEquals(ErrorProp) - Method in class flanagan.analysis.ErrorProp
 
minusEquals(double) - Method in class flanagan.analysis.ErrorProp
 
minusEquals(Matrix) - Method in class flanagan.math.Matrix
 
minusEquals(ValueErr, double) - Method in class jhplot.math.ValueErr
Subtract a ValueErr number to this ValueErr number and replace this with the sum with correlation
minusEquals(ValueErr) - Method in class jhplot.math.ValueErr
Subtract a ValueErr number from this ValueErr number and replace this with the sum with no correlation
minusEquals(double) - Method in class jhplot.math.ValueErr
Subtract a double number from this ValueErr number and replace this with the sum
minusError(int, double) - Method in interface hep.aida.ref.dataset.binner.BinError
Get the minus error on a bin.
minusError(int[]) - Method in interface hep.aida.ref.dataset.binner.Binner
Get the minus error on a bin.
minusError(int[]) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Get the minus error on a bin.
minusError(int, double) - Method in class hep.aida.ref.dataset.binner.EfficiencyBinError
Get the minus error on a bin.
minusError(int, double) - Method in class hep.aida.ref.dataset.binner.GaussianBinError
Get the minus error on a bin.
minusError(int, double) - Method in class hep.aida.ref.dataset.binner.PoissonBinError
Get the minus error on a bin.
minusError() - Method in class hep.aida.ref.fitter.fitdata.FitDataIterator
 
minusError(int) - Method in class hep.aida.ref.histogram.binner.BasicBinner1D
 
minusError(int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
minusError(int, int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
minusError(int) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
minusError(int, int) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
minusError(int, int, int) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
minusError(int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner1D
 
minusError(int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
minusError(int, int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
minusMult(DoubleMatrix1D, DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A - B*s <=> A[i] = A[i] - B[i]*s.
minusMult(DoubleMatrix2D, DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A - B*s <=> A[row,col] = A[row,col] - B[row,col]*s.
minusMult(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a - b*constant.
minusMult(double) - Static method in class cern.jet.math.PlusMult
a - b*constant.
minusMult(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
minusMult(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexPlusMultFirst
a - b*constant.
minusMult(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexPlusMultSecond
a - b*constant.
minusMult(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a - b*constant.
minusMult(double) - Static method in class cern.jet.math.tdouble.DoublePlusMultFirst
a - b*constant.
minusMult(double) - Static method in class cern.jet.math.tdouble.DoublePlusMultSecond
a - b*constant.
minusMult(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
minusMult(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexPlusMultFirst
a - b*constant.
minusMult(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexPlusMultSecond
a - b*constant.
minusMult(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a - b*constant.
minusMult(float) - Static method in class cern.jet.math.tfloat.FloatPlusMultFirst
a*constant - b.
minusMult(float) - Static method in class cern.jet.math.tfloat.FloatPlusMultSecond
a - b*constant.
minusMult(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a - b*constant.
minusMult(int) - Static method in class cern.jet.math.tint.IntPlusMultFirst
a - b*constant.
minusMult(int) - Static method in class cern.jet.math.tint.IntPlusMultSecond
a - b*constant.
minusMult(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a - b*constant.
minusMult(long) - Static method in class cern.jet.math.tlong.LongPlusMultFirst
a - b*constant.
minusMult(long) - Static method in class cern.jet.math.tlong.LongPlusMultSecond
a - b*constant.
minusOne() - Static method in class flanagan.analysis.ErrorProp
 
minusReal(double) - Method in class jhplot.math.Complex
Subtraction from real part
minusxLog10x() - Method in class flanagan.analysis.Stat
 
minusxLog10x() - Method in class flanagan.math.ArrayMaths
 
minusxLog2x() - Method in class flanagan.analysis.Stat
 
minusxLog2x() - Method in class flanagan.math.ArrayMaths
 
minusxLogEx() - Method in class flanagan.analysis.Stat
 
minusxLogEx() - Method in class flanagan.math.ArrayMaths
 
minutes() - Method in class cern.colt.Timer
Returns the elapsed time in minutes; does not stop the timer, if started.
minValue(Value) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
minValue(Value) - Method in interface hep.aida.ref.tuple.FTupleColumn
 
minValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn
 
Misc - Class in umontreal.iro.lecuyer.util
This class provides miscellaneous functions that are hard to classify.
mkdir(String) - Method in class hep.aida.ref.tree.Tree
Create a new directory.
mkdirs(String) - Method in class hep.aida.ref.tree.Tree
Create a directory recursively.
mm - Static variable in class cern.clhep.Units
 
mm2 - Static variable in class cern.clhep.Units
 
mm3 - Static variable in class cern.clhep.Units
 
mod - Static variable in class cern.jet.math.Functions
Function that returns a % b.
mod(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a % b.
mod - Static variable in class cern.jet.math.IntFunctions
Function that returns a % b.
mod(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a % b.
mod - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a % b.
mod(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a % b.
mod - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a % b.
mod(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a % b.
mod - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a % b.
mod(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a % b.
mod - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a % b.
mod(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a % b.
mod() - Method in class jhplot.math.Complex
Modulus of this Complex number (the distance from the origin in polar coordinates).
modBesselIo(double) - Static method in class flanagan.math.FourierTransform
 
Model3d - Class in jhplot.v3d
 
Model3d(Applet, int, int) - Constructor for class jhplot.v3d.Model3d
 
modifyName(String) - Static method in class hep.aida.ref.AidaUtils
 
molarToPercentWeightByVol(double, double) - Static method in class flanagan.math.Conv
 
molarToPercentWeightByVol(double, double) - Static method in class flanagan.math.Fmath
 
mole - Static variable in class cern.clhep.Units
 
moment(int, double) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
moment(int, double) - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
moment(int, double, int, double[]) - Static method in class cern.jet.stat.Descriptive
Returns the moment of k-th order with constant c of a data sequence, which is Sum( (data[i]-c)k ) / data.size().
moment(DoubleArrayList, int, double) - Static method in class cern.jet.stat.Descriptive
Returns the moment of k-th order with constant c of a data sequence, which is Sum( (data[i]-c)k ) / data.size().
moment(int, double, int, double[]) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the moment of k-th order with constant c of a data sequence, which is Sum( (data[i]-c)k ) / data.size().
moment(DoubleArrayList, int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the moment of k-th order with constant c of a data sequence, which is Sum( (data[i]-c)k ) / data.size().
moment(int, float, int, float[]) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the moment of k-th order with constant c of a data sequence, which is Sum( (data[i]-c)k ) / data.size().
moment(FloatArrayList, int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the moment of k-th order with constant c of a data sequence, which is Sum( (data[i]-c)k ) / data.size().
moment(int, double) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
moment(int, double) - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
moment(int, float) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
moment(int, float) - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
moment(int, double) - Method in class jhplot.P0D
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
moment(int, Integer) - Method in class jhplot.P0I
Returns the moment of k-th order with value c, which is Sum( (x[i]-c)k ) / size().
Moments - Class in jhpro.stat
Calculations of moments of a distribution.
Moments(int) - Constructor for class jhpro.stat.Moments
Initialization of the moments.
MomentsFac - Class in jhpro.stat
Calculations of factorial moments of a distribution.
MomentsFac(int) - Constructor for class jhpro.stat.MomentsFac
Initialization of the factorial moments.
MomentsFacNorm - Class in jhpro.stat
Calculations of normalized factorial moments of a distribution.
MomentsFacNorm(int) - Constructor for class jhpro.stat.MomentsFacNorm
Initialization of the normalised factorial moments.
momentSkewness() - Method in class flanagan.analysis.Stat
 
momentSkewness(double[]) - Static method in class flanagan.analysis.Stat
 
momentSkewness(float[]) - Static method in class flanagan.analysis.Stat
 
momentSkewness(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
momentSkewness(long[]) - Static method in class flanagan.analysis.Stat
 
momentSkewness(int[]) - Static method in class flanagan.analysis.Stat
 
momentSkewness_as_double() - Method in class flanagan.analysis.Stat
 
MomentsNorm - Class in jhpro.stat
Calculations of normalized reduced moments of a distribution.
MomentsNorm(int) - Constructor for class jhpro.stat.MomentsNorm
Initialization of the normalised factorial moments.
monitor(double, DoubleMatrix1D, int) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationReporter
Registers current information
monitor(double, int) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationReporter
Registers current information
monitor(double, int) - Method in class cern.colt.matrix.tdouble.algo.solver.NoDoubleIterationReporter
 
monitor(double, DoubleMatrix1D, int) - Method in class cern.colt.matrix.tdouble.algo.solver.NoDoubleIterationReporter
 
monitor(float, FloatMatrix1D, int) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationReporter
Registers current information
monitor(float, int) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationReporter
Registers current information
monitor(float, int) - Method in class cern.colt.matrix.tfloat.algo.solver.NoFloatIterationReporter
 
monitor(float, FloatMatrix1D, int) - Method in class cern.colt.matrix.tfloat.algo.solver.NoFloatIterationReporter
 
monteCarlo() - Method in class flanagan.analysis.PCA
 
monteCarloEigenValues() - Method in class flanagan.analysis.PCA
 
monteCarloMeans() - Method in class flanagan.analysis.PCA
 
monteCarloPercentiles() - Method in class flanagan.analysis.PCA
 
monteCarloStandardDeviations() - Method in class flanagan.analysis.PCA
 
mostSignificantBit(int) - Static method in class cern.colt.bitvector.QuickBitVector
Returns the index of the most significant bit in state "true".
mostSignificantBit(int) - Static method in class cern.colt.matrix.tbit.QuickBitVector
Returns the index of the most significant bit in state "true".
mothersDayUK() - Method in class flanagan.math.TimeAndDate
 
mothersDayUK(int) - Method in class flanagan.math.TimeAndDate
 
mothersDayUS() - Method in class flanagan.math.TimeAndDate
 
mothersDayUS(int) - Method in class flanagan.math.TimeAndDate
 
mount(String, ITree, String) - Method in class hep.aida.ref.tree.Tree
Mounts a tree within another (target) tree.
MountPoint - Class in hep.aida.ref.tree
A mount point allows one tree to be "mounted" in another.
mouseDown(Event, int, int) - Method in class jhplot.v3d.Animation
 
MOVE - Static variable in class jhplot.jadraw.JaObject
An integer that indicates the current edit mode MOVE.
move(String, String) - Method in class jhplot.P1D
Transform a P1D data holder to some function with error propagation (for both levels)
moveBy(int, int) - Method in class jhplot.jadraw.JaArcObject
Shifts the elements of the vector containing the three click points of this arc.
moveBy(int, int) - Method in class jhplot.jadraw.JaObject
Reset the x, and y coordinates of the object when it is moved by deltaX and deltaY.
moveBy(int, int) - Method in class jhplot.jadraw.JaVertexT5
Shifts the elements of the vector containing the three corner points of this vertex.
MoyalCoreNotNorm - Class in hep.aida.ref.function
 
MoyalCoreNotNorm(String) - Constructor for class hep.aida.ref.function.MoyalCoreNotNorm
 
MoyalCoreNotNorm(String, double[]) - Constructor for class hep.aida.ref.function.MoyalCoreNotNorm
 
mrad - Static variable in class cern.clhep.Units
 
MRG31k3p - Class in umontreal.iro.lecuyer.rng
Extends the abstract class RandomStreamBase, thus implementing the RandomStream interface indirectly.
MRG31k3p() - Constructor for class umontreal.iro.lecuyer.rng.MRG31k3p
Constructs a new stream, initialized at its beginning.
MRG31k3p(String) - Constructor for class umontreal.iro.lecuyer.rng.MRG31k3p
Constructs a new stream with the identifier name (used when formatting the stream state).
MRG32k3a - Class in umontreal.iro.lecuyer.rng
Extends the abstract class RandomStreamBase by using as a backbone (or main) generator the combined multiple recursive generator (CMRG) MRG32k3a proposed by L'Ecuyer, implemented in 64-bit floating-point arithmetic.
MRG32k3a() - Constructor for class umontreal.iro.lecuyer.rng.MRG32k3a
Constructs a new stream, initializes its seed Ig, sets Bg and Cg equal to Ig, and sets its antithetic switch to false.
MRG32k3a(String) - Constructor for class umontreal.iro.lecuyer.rng.MRG32k3a
Constructs a new stream with an identifier name (used when printing the stream state).
MRG32k3aL - Class in umontreal.iro.lecuyer.rng
The same generator as MRG32k3a, except here it is implemented with type long instead of double.
MRG32k3aL() - Constructor for class umontreal.iro.lecuyer.rng.MRG32k3aL
 
MRG32k3aL(String) - Constructor for class umontreal.iro.lecuyer.rng.MRG32k3aL
 
MRNSDDoubleIterationMonitor - Class in cern.colt.matrix.tdouble.algo.solver
 
MRNSDDoubleIterationMonitor() - Constructor for class cern.colt.matrix.tdouble.algo.solver.MRNSDDoubleIterationMonitor
 
MRNSDFloatIterationMonitor - Class in cern.colt.matrix.tfloat.algo.solver
 
MRNSDFloatIterationMonitor() - Constructor for class cern.colt.matrix.tfloat.algo.solver.MRNSDFloatIterationMonitor
 
ms - Static variable in class cern.clhep.Units
 
mt() - Method in class hephysics.vec.HepLorentzVector
Transverse mass.
MT19937 - Class in umontreal.iro.lecuyer.rng
Implements the RandomStream interface via inheritance from RandomStreamBase.
MT19937(CloneableRandomStream) - Constructor for class umontreal.iro.lecuyer.rng.MT19937
Constructs a new stream, using rng to fill its initial state.
MT19937(CloneableRandomStream, String) - Constructor for class umontreal.iro.lecuyer.rng.MT19937
Constructs a new stream with the identifier name (used in the toString method).
mt2() - Method in class hephysics.vec.HepLorentzVector
Transverse mass: e()*e() - pz()*pz()
mu0 - Static variable in class cern.clhep.PhysicalConstants
 
MU_0 - Static variable in class flanagan.math.Fmath
 
mul(Binner1D, Binner1D, Binner1D) - Static method in class hep.aida.ref.histogram.binner.BinnerMath
 
mul(Vector3d) - Method in class jhplot.v3d.Vector3d
 
mul(float) - Method in class jhplot.v3d.Vector3d
 
mulAndCheck(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Multiply two integers, checking for overflow.
mulAndCheck(long, long) - Static method in class org.apache.commons.math.util.MathUtils
Multiply two long integers, checking for overflow.
mulipliedEntriesWith(Matrix) - Method in class jhplot.bsom.Matrix
Multiply entries.
MullerSolver - Class in org.apache.commons.math.analysis.solvers
Implements the Muller's Method for root finding of real univariate functions.
MullerSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.solvers.MullerSolver
Deprecated. as of 2.0 the function to solve is passed as an argument to the MullerSolver.solve(UnivariateRealFunction, double, double) or UnivariateRealSolver.solve(UnivariateRealFunction, double, double, double) method.
MullerSolver() - Constructor for class org.apache.commons.math.analysis.solvers.MullerSolver
Deprecated. in 2.2 (to be removed in 3.0).
mult(DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A * s <=> A[i] = A[i] * s.
mult(DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A * B <=> A[i] = A[i] * B[i].
mult(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A * s <=> A[row,col] = A[row,col] * s.
mult(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A * B <=> A[row,col] = A[row,col] * B[row,col].
mult(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Algebra
Inner product of two vectors; Sum(x[i] * y[i]).
mult(DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Algebra
Linear algebraic matrix-vector multiplication; z = A * y.
mult(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Linear algebraic matrix-matrix multiplication; C = A x B.
mult(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Inner product of two vectors; Sum(x[i] * y[i]).
mult(DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Linear algebraic matrix-vector multiplication; z = A * y.
mult(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Linear algebraic matrix-matrix multiplication; C = A x B.
mult(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Inner product of two vectors; Sum(x[i] * y[i]).
mult(FloatMatrix2D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Linear algebraic matrix-vector multiplication; z = A * y.
mult(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Linear algebraic matrix-matrix multiplication; C = A x B.
mult - Static variable in class cern.jet.math.Functions
Function that returns a * b.
mult(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a * b.
mult - Static variable in class cern.jet.math.IntFunctions
Function that returns a * b.
mult(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a * b.
Mult - Class in cern.jet.math
Only for performance tuning of compute intensive linear algebraic computations.
mult(double) - Static method in class cern.jet.math.Mult
a * constant.
mult(double[], double) - Static method in class cern.jet.math.tdcomplex.DComplex
 
mult(double[], double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
mult - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
mult(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
mult(double) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
mult(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexMult
a * constant.
mult - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a * b.
mult(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a * b.
mult(double) - Static method in class cern.jet.math.tdouble.DoubleMult
a * constant.
mult(float[], float) - Static method in class cern.jet.math.tfcomplex.FComplex
 
mult(float[], float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
mult - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
mult(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
mult(float) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
mult(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexMult
a * constant.
mult - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a * b.
mult(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a * b.
mult(float) - Static method in class cern.jet.math.tfloat.FloatMult
a * constant.
mult - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a * b.
mult(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a * b.
mult(int) - Static method in class cern.jet.math.tint.IntMult
a * constant.
mult - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a * b.
mult(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a * b.
mult(long) - Static method in class cern.jet.math.tlong.LongMult
a * constant.
mult(Matrix, Matrix) - Static method in class hephysics.matrix.MatrixOp
 
mult(Hep3Matrix, Hep3Matrix) - Static method in class hephysics.vec.Hep3Matrix
 
mult(double, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Multiply by a scaler
mult(double) - Method in class hephysics.vec.Hep3Vector
Multiply by a scaler
mult(Hep3Matrix, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
 
mult(double, HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Multiply by a scaler
mult(double, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
mult(Hep3Matrix, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
mult(Hep3Matrix, Hep3Matrix) - Static method in class hephysics.vec.VecOp
 
mult(double, Hep3Matrix) - Static method in class hephysics.vec.VecOp
 
multConjFirst - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
multConjFirst - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
multConjSecond - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
multConjSecond - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
MultidimensionalCounter - Class in org.apache.commons.math.util
Converter between unidimensional storage structure and multidimensional conceptual structure.
MultidimensionalCounter(int...) - Constructor for class org.apache.commons.math.util.MultidimensionalCounter
Create a counter.
MultidimensionalCounter.Iterator - Class in org.apache.commons.math.util
Perform iteration over the multidimensional counter.
MultiDirectional - Class in org.apache.commons.math.optimization.direct
This class implements the multi-directional direct search method.
MultiDirectional() - Constructor for class org.apache.commons.math.optimization.direct.MultiDirectional
Build a multi-directional optimizer with default coefficients.
MultiDirectional(double, double) - Constructor for class org.apache.commons.math.optimization.direct.MultiDirectional
Build a multi-directional optimizer with specified coefficients.
MultinomialDist - Class in umontreal.iro.lecuyer.probdistmulti
Implements the abstract class DiscreteDistributionIntMulti for the multinomial distribution with parameters n and (p1, ...,pd).
MultinomialDist(int, double[]) - Constructor for class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Creates a MultinomialDist object with parameters n and (p1,...,pd) such that i=1dpi = 1.
MultinormalCholeskyGen - Class in umontreal.iro.lecuyer.randvarmulti
Extends MultinormalGen for a multivariate normal distribution, generated via a Cholesky decomposition of the covariance matrix.
MultinormalCholeskyGen(NormalGen, double[], double[][]) - Constructor for class umontreal.iro.lecuyer.randvarmulti.MultinormalCholeskyGen
Equivalent to MultinormalCholeskyGen(gen1, mu, new DenseDoubleMatrix2D(sigma)).
MultinormalCholeskyGen(NormalGen, double[], DoubleMatrix2D) - Constructor for class umontreal.iro.lecuyer.randvarmulti.MultinormalCholeskyGen
Constructs a multinormal generator with mean vector mu and covariance matrix sigma.
MultiNormalDist - Class in umontreal.iro.lecuyer.probdistmulti
Implements the abstract class ContinuousDistributionMulti for the multinormal distribution with mean vector μ and covariance matrix Σ.
MultiNormalDist(double[], double[][]) - Constructor for class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
 
MultinormalGen - Class in umontreal.iro.lecuyer.randvarmulti
Extends RandomMultivariateGen for a multivariate normal (or multinormal) distribution.
MultinormalGen(NormalGen, int) - Constructor for class umontreal.iro.lecuyer.randvarmulti.MultinormalGen
Constructs a generator with the standard multinormal distribution (with μ = 0 and Σ = I) in d dimensions.
MultinormalPCAGen - Class in umontreal.iro.lecuyer.randvarmulti
Extends MultinormalGen for a multivariate normal distribution, generated via the method of principal components analysis (PCA) of the covariance matrix.
MultinormalPCAGen(NormalGen, double[], double[][]) - Constructor for class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Equivalent to MultinormalPCAGen(gen1, mu, new DenseDoubleMatrix2D(sigma)).
MultinormalPCAGen(NormalGen, double[], DoubleMatrix2D) - Constructor for class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Constructs a multinormal generator with mean vector mu and covariance matrix sigma.
MultipleDatasetChart - Class in umontreal.iro.lecuyer.charts
Provides tools to plot many datasets on the same chart.
MultipleDatasetChart() - Constructor for class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Initializes a new MultipleDatasetChart.
MultipleDatasetChart(String, String, String) - Constructor for class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Initializes a new MultipleDatasetChart instance.
MultipleLinearRegression - Interface in org.apache.commons.math.stat.regression
The multiple linear regression can be represented in matrix-notation.
MULTIPLICATIVE_MODE - Static variable in class org.apache.commons.math.util.ResizableDoubleArray
multiplicative expansion mode
multiplicator - Variable in class cern.jet.math.Mult
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.PlusMult
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tdcomplex.DComplexMult
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tdcomplex.DComplexPlusMultFirst
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tdcomplex.DComplexPlusMultSecond
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tdouble.DoubleMult
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tdouble.DoublePlusMultFirst
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tdouble.DoublePlusMultSecond
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tfcomplex.FComplexMult
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tfcomplex.FComplexPlusMultFirst
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tfcomplex.FComplexPlusMultSecond
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tfloat.FloatMult
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tfloat.FloatPlusMultFirst
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tfloat.FloatPlusMultSecond
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tint.IntMult
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tint.IntPlusMultFirst
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tint.IntPlusMultSecond
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tlong.LongMult
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tlong.LongPlusMultFirst
Public read/write access to avoid frequent object construction.
multiplicator - Variable in class cern.jet.math.tlong.LongPlusMultSecond
Public read/write access to avoid frequent object construction.
multipliedBy(double) - Method in class jhplot.bsom.Matrix
Scalar product: aX.
multipliedBy(Matrix) - Method in class jhplot.bsom.Matrix
Matrix multiplication: X*Y.
multiply(String, IDataPointSet, IDataPointSet) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
multiply(String, IHistogram1D, IHistogram1D) - Method in class hep.aida.ref.histogram.HistogramFactory
Multiplies two 1D Histogram
multiply(String, IHistogram2D, IHistogram2D) - Method in class hep.aida.ref.histogram.HistogramFactory
Multiplies two 2D Histogram
multiply(String, IHistogram3D, IHistogram3D) - Method in class hep.aida.ref.histogram.HistogramFactory
Multiplies two 3D Histogram
MULTIPLY - Static variable in class org.apache.commons.math.analysis.BinaryFunction
Deprecated. The * operator method wrapped as a BinaryFunction.
multiply(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.ComposableFunction
Return a function multiplying the instance and another function.
multiply(double) - Method in class org.apache.commons.math.analysis.ComposableFunction
Return a function scaling the instance by a constant factor.
multiply(PolynomialFunction) - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Multiply the instance by a polynomial.
multiply(Complex) - Method in class org.apache.commons.math.complex.Complex
Return the product of this complex number and the given complex number.
multiply(double) - Method in class org.apache.commons.math.complex.Complex
Return the product of this complex number and the given scalar number.
multiply(Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Multiply this by x.
multiply(int) - Method in class org.apache.commons.math.dfp.Dfp
Multiply this by a single digit 0<=x<radix.
multiply(T) - Method in interface org.apache.commons.math.FieldElement
Compute this × a.
multiply(BigInteger) - Method in class org.apache.commons.math.fraction.BigFraction
Multiplies the value of this fraction by the passed BigInteger, returning the result in reduced form.
multiply(int) - Method in class org.apache.commons.math.fraction.BigFraction
Multiply the value of this fraction by the passed int, returning the result in reduced form.
multiply(long) - Method in class org.apache.commons.math.fraction.BigFraction
Multiply the value of this fraction by the passed long, returning the result in reduced form.
multiply(BigFraction) - Method in class org.apache.commons.math.fraction.BigFraction
Multiplies the value of this fraction by another, returning the result in reduced form.
multiply(Fraction) - Method in class org.apache.commons.math.fraction.Fraction
Multiplies the value of this fraction by another, returning the result in reduced form.
multiply(int) - Method in class org.apache.commons.math.fraction.Fraction
Multiply the fraction by an integer.
multiply(FieldMatrix<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the result of postmultiplying this by m.
multiply(FieldMatrix<T>) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Returns the result of postmultiplying this by m.
multiply(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Returns the result of postmultiplying this by m.
multiply(Array2DRowRealMatrix) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Returns the result of postmultiplying this by m.
multiply(BigMatrix) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the result of postmultiplying this by m.
multiply(BigMatrix) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the result of postmultiplying this by m.
multiply(BigMatrixImpl) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the result of postmultiplying this by m.
multiply(FieldMatrix<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the result of postmultiplying this by m.
multiply(BlockFieldMatrix<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the result of postmultiplying this by m.
multiply(BlockRealMatrix) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the result of postmultiplying this by m.
multiply(FieldMatrix<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Returns the result of postmultiplying this by m.
multiply(OpenMapRealMatrix) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result of postmultiplying this by m.
multiply(RealMatrix) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Returns the result of postmultiplying this by m.
multiply(RealMatrixImpl) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Returns the result of postmultiplying this by m.
multiply(BigReal) - Method in class org.apache.commons.math.util.BigReal
Compute this × a.
multiply(BitVector) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Multiplies the column BitVector by a BitMatrix and returns the result.
multiply(int) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Multiplies vect, seen as a column BitVector, by a BitMatrix.
multiply(BitMatrix) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Multiplies two BitMatrix's together.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, T) - Method in interface org.apache.commons.math.linear.FieldMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in interface org.apache.commons.math.linear.RealMatrix
Change an entry in the specified row and column.
multiplyEntry(int, int, double) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Change an entry in the specified row and column.
multiplyEntry(int, int, T) - Method in class org.apache.commons.math.linear.SparseFieldMatrix
Change an entry in the specified row and column.
MultiStartDifferentiableMultivariateRealOptimizer - Class in org.apache.commons.math.optimization
Special implementation of the DifferentiableMultivariateRealOptimizer interface adding multi-start features to an existing optimizer.
MultiStartDifferentiableMultivariateRealOptimizer(DifferentiableMultivariateRealOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Create a multi-start optimizer from a single-start optimizer
MultiStartDifferentiableMultivariateVectorialOptimizer - Class in org.apache.commons.math.optimization
Special implementation of the DifferentiableMultivariateVectorialOptimizer interface adding multi-start features to an existing optimizer.
MultiStartDifferentiableMultivariateVectorialOptimizer(DifferentiableMultivariateVectorialOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Create a multi-start optimizer from a single-start optimizer
MultiStartMultivariateRealOptimizer - Class in org.apache.commons.math.optimization
Special implementation of the MultivariateRealOptimizer interface adding multi-start features to an existing optimizer.
MultiStartMultivariateRealOptimizer(MultivariateRealOptimizer, int, RandomVectorGenerator) - Constructor for class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Create a multi-start optimizer from a single-start optimizer
MultiStartUnivariateRealOptimizer - Class in org.apache.commons.math.optimization
Special implementation of the UnivariateRealOptimizer interface adding multi-start features to an existing optimizer.
MultiStartUnivariateRealOptimizer(UnivariateRealOptimizer, int, RandomGenerator) - Constructor for class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Create a multi-start optimizer from a single-start optimizer
MultistepIntegrator - Class in org.apache.commons.math.ode
This class is the base class for multistep integrators for Ordinary Differential Equations.
MultistepIntegrator.NordsieckTransformer - Interface in org.apache.commons.math.ode
Transformer used to convert the first step to Nordsieck representation.
MultivariateFunction - Interface in umontreal.iro.lecuyer.util
Represents a function of multiple variables.
MultivariateMatrixFunction - Interface in org.apache.commons.math.analysis
An interface representing a multivariate matrix function.
MultivariateRealFunction - Interface in org.apache.commons.math.analysis
An interface representing a multivariate real function.
MultivariateRealInterpolator - Interface in org.apache.commons.math.analysis.interpolation
Interface representing a univariate real interpolating function.
MultivariateRealOptimizer - Interface in org.apache.commons.math.optimization
This interface represents an optimization algorithm for scalar objective functions.
MultivariateSummaryStatistics - Class in org.apache.commons.math.stat.descriptive
Computes summary statistics for a stream of n-tuples added using the addValue method.
MultivariateSummaryStatistics(int, boolean) - Constructor for class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Construct a MultivariateSummaryStatistics instance
MultivariateVectorialFunction - Interface in org.apache.commons.math.analysis
An interface representing a multivariate vectorial function.
multModM(double, double, double, double) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Computes (a×s + c) mod m.
multModM(int, int, int, int) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Computes (a×s + c) mod m.
multModM(long, long, long, long) - Static method in class umontreal.iro.lecuyer.util.ArithmeticMod
Computes (a×s + c) mod m.
multNeg - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns -(a * b).
multNeg - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns -(a * b).
multNeg - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns -(a * b).
multNeg - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns -(a * b).
multOuter(DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Outer product of two vectors; Sets A[i,j] = x[i] * y[j].
multOuter(DoubleMatrix1D, DoubleMatrix1D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Outer product of two vectors; Sets A[i,j] = x[i] * y[j].
multOuter(FloatMatrix1D, FloatMatrix1D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Outer product of two vectors; Sets A[i,j] = x[i] * y[j].
multSecond(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns b*constant.
multSecond(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
 
multSecond(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns b*constant.
multSecond(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns b*constant.
multSquare - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a * b^2.
multSquare - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a * b^2.
multSquare - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a * b^2.
multSquare - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a * b^2.
MutableMatrix - Interface in hephysics.matrix
A matrix that can be changed
mutate(Chromosome) - Method in class org.apache.commons.math.genetics.BinaryMutation
Mutate the given chromosome.
mutate(Chromosome) - Method in interface org.apache.commons.math.genetics.MutationPolicy
Mutate the given chromosome.
mutate(Chromosome) - Method in class org.apache.commons.math.genetics.RandomKeyMutation
Mutate the given chromosome.
MutationPolicy - Interface in org.apache.commons.math.genetics
Algorithm used to mutate a chrommosome.
mv(String, String) - Method in class hep.aida.ref.tree.Tree
Move an IManagedObject or a directory from one directory to another.

N

N_AVAGADRO - Static variable in class flanagan.math.Fmath
 
NakagamiDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Nakagami distribution with location parameter a, scale parameter λ > 0 and shape parameter c > 0.
NakagamiDist(double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.NakagamiDist
Constructs a NakagamiDist object with parameters a = a, λ = lambda and c = c.
NakagamiGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the Nakagami distribution.
NakagamiGen(RandomStream, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.NakagamiGen
Creates a new Nakagami generator with parameters a = a, λ = lambda and c = c, using stream s.
NakagamiGen(RandomStream, NakagamiDist) - Constructor for class umontreal.iro.lecuyer.randvar.NakagamiGen
Creates a new generator for the distribution dist, using stream s.
name() - Method in interface cern.hep.aida.bin.BinFunction1D
Returns the name of this function.
name() - Method in class hep.aida.ref.fitter.FitParameterSettings
 
name() - Method in class hep.aida.ref.ManagedObject
Get the name of this ManagedObject.
name() - Method in class hep.aida.ref.tree.Tree
 
name() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
name() - Method in interface hep.aida.ref.tuple.FTuple
 
name() - Method in class hep.aida.ref.tuple.FTupleAdapter
 
name() - Method in interface hep.aida.ref.tuple.FTupleColumn
 
name() - Method in class hep.aida.ref.tuple.TupleColumn
 
name() - Method in interface hep.aida.tdouble.bin.DoubleBinFunction1D
Returns the name of this function.
name() - Method in interface hep.aida.tfloat.bin.FloatBinFunction1D
Returns the name of this function.
NameConflictException - Exception in umontreal.iro.lecuyer.util
This exception is thrown by a ClassFinder when two or more fully qualified class names can be associated with a simple class name.
NameConflictException() - Constructor for exception umontreal.iro.lecuyer.util.NameConflictException
Constructs a new name conflict exception.
NameConflictException(String) - Constructor for exception umontreal.iro.lecuyer.util.NameConflictException
Constructs a new name conflict exception with message message.
NameConflictException(ClassFinder, String, String) - Constructor for exception umontreal.iro.lecuyer.util.NameConflictException
Constructs a new name conflict exception with class finder finder, simple name name, and message message.
NaN - Static variable in class org.apache.commons.math.complex.Complex
A complex number representing "NaN + NaNi"
NaN - Static variable in class org.apache.commons.math.geometry.Vector3D
A vector with all coordinates set to NaN.
nanEntries() - Method in class hep.aida.ref.histogram.AbstractBaseHistogram
Number of entries whose coordinate or weight is NaN.
nanEntries() - Method in class hep.aida.ref.histogram.Cloud
 
nanEntries() - Method in class hep.aida.ref.histogram.Histogram
 
nanEntries() - Method in class hep.aida.ref.histogram.Profile
 
nanoampere - Static variable in class cern.clhep.Units
 
nanobarn - Static variable in class cern.clhep.Units
 
nanofarad - Static variable in class cern.clhep.Units
 
nanometer - Static variable in class cern.clhep.Units
 
nanos() - Method in class cern.colt.Timer
Returns the elapsed time in nano seconds; does not stop the timer, if started.
nanosecond - Static variable in class cern.clhep.Units
 
NaNStrategy - Enum in org.apache.commons.math.stat.ranking
Strategies for handling NaN values in rank transformations.
nativityBlessedVirgin() - Method in class flanagan.math.TimeAndDate
 
nativityBlessedVirgin(int) - Method in class flanagan.math.TimeAndDate
 
NaturalRanking - Class in org.apache.commons.math.stat.ranking
Ranking based on the natural ordering on doubles.
NaturalRanking() - Constructor for class org.apache.commons.math.stat.ranking.NaturalRanking
Create a NaturalRanking with default strategies for handling ties and NaNs.
NaturalRanking(TiesStrategy) - Constructor for class org.apache.commons.math.stat.ranking.NaturalRanking
Create a NaturalRanking with the given TiesStrategy.
NaturalRanking(NaNStrategy) - Constructor for class org.apache.commons.math.stat.ranking.NaturalRanking
Create a NaturalRanking with the given NaNStrategy.
NaturalRanking(NaNStrategy, TiesStrategy) - Constructor for class org.apache.commons.math.stat.ranking.NaturalRanking
Create a NaturalRanking with the given NaNStrategy and TiesStrategy.
NaturalRanking(RandomGenerator) - Constructor for class org.apache.commons.math.stat.ranking.NaturalRanking
Create a NaturalRanking with TiesStrategy.RANDOM and the given RandomGenerator as the source of random data.
NaturalRanking(NaNStrategy, RandomGenerator) - Constructor for class org.apache.commons.math.stat.ranking.NaturalRanking
Create a NaturalRanking with the given NaNStrategy, TiesStrategy.RANDOM and the given source of random data.
nbCategories - Variable in class umontreal.iro.lecuyer.gof.GofStat.OutcomeCategoriesChi2
Total number of categories.
nbExp - Variable in class umontreal.iro.lecuyer.gof.GofStat.OutcomeCategoriesChi2
Expected number of observations for each category.
nBins() - Method in class hep.aida.ref.function.Grid
 
nBoxes() - Method in class hep.aida.ref.function.Grid
 
nColumns() - Method in class flanagan.analysis.RankAnalysis
 
ndf() - Method in class hep.aida.ref.fitter.FitResult
 
nDiagonalElements() - Method in class flanagan.analysis.RankAnalysis
 
nearestElementIndex(double[], double) - Static method in class flanagan.math.Fmath
 
nearestElementIndex(int[], int) - Static method in class flanagan.math.Fmath
 
nearestElementValue(double[], double) - Static method in class flanagan.math.Fmath
 
nearestElementValue(int[], int) - Static method in class flanagan.math.Fmath
 
nearestHigherElementIndex(double[], double) - Static method in class flanagan.math.Fmath
 
nearestHigherElementIndex(int[], int) - Static method in class flanagan.math.Fmath
 
nearestHigherElementValue(double[], double) - Static method in class flanagan.math.Fmath
 
nearestHigherElementValue(int[], int) - Static method in class flanagan.math.Fmath
 
nearestIndex(double) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(Double) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(float) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(Float) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(long) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(Long) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(int) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(Integer) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(short) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(Short) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(byte) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(Byte) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(char) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(Character) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(BigDecimal) - Method in class flanagan.math.ArrayMaths
 
nearestIndex(BigInteger) - Method in class flanagan.math.ArrayMaths
 
nearestLowerElementIndex(double[], double) - Static method in class flanagan.math.Fmath
 
nearestLowerElementIndex(int[], int) - Static method in class flanagan.math.Fmath
 
nearestLowerElementValue(double[], double) - Static method in class flanagan.math.Fmath
 
nearestLowerElementValue(int[], int) - Static method in class flanagan.math.Fmath
 
nearestValue(double) - Method in class flanagan.math.ArrayMaths
 
nearestValue(Double) - Method in class flanagan.math.ArrayMaths
 
nearestValue(float) - Method in class flanagan.math.ArrayMaths
 
nearestValue(Float) - Method in class flanagan.math.ArrayMaths
 
nearestValue(long) - Method in class flanagan.math.ArrayMaths
 
nearestValue(Long) - Method in class flanagan.math.ArrayMaths
 
nearestValue(int) - Method in class flanagan.math.ArrayMaths
 
nearestValue(Integer) - Method in class flanagan.math.ArrayMaths
 
nearestValue(short) - Method in class flanagan.math.ArrayMaths
 
nearestValue(Short) - Method in class flanagan.math.ArrayMaths
 
nearestValue(byte) - Method in class flanagan.math.ArrayMaths
 
nearestValue(Byte) - Method in class flanagan.math.ArrayMaths
 
nearestValue(char) - Method in class flanagan.math.ArrayMaths
 
nearestValue(Character) - Method in class flanagan.math.ArrayMaths
 
nearestValue(BigDecimal) - Method in class flanagan.math.ArrayMaths
 
nearestValue(BigInteger) - Method in class flanagan.math.ArrayMaths
 
neg - Static variable in class cern.jet.math.Functions
Function that returns -a.
neg - Static variable in class cern.jet.math.IntFunctions
Function that returns -a.
neg(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
neg - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
neg - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns -a.
neg(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
neg - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
neg - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns -a.
neg - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns -a.
neg - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns -a.
neg(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Invert
neg(HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Inverse
neg(Hep3Vector) - Method in class hephysics.vec.HepLorentzVector
 
neg(Hep3Vector) - Static method in class hephysics.vec.VecOp
 
negate(DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = -A <=> A[i] = -A[i] for all cells.
negate(DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = -A <=> A[row,col] = -A[row,col].
negate() - Method in class flanagan.analysis.Stat
 
negate() - Method in class flanagan.math.ArrayMaths
 
NEGATE - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The - operator wrapped as a ComposableFunction.
negate() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Negate the instance.
negate() - Method in class org.apache.commons.math.complex.Complex
Return the additive inverse of this complex number.
negate() - Method in class org.apache.commons.math.dfp.Dfp
Returns a number that is this number with the sign bit reversed.
negate() - Method in class org.apache.commons.math.fraction.BigFraction
Return the additive inverse of this fraction, returning the result in reduced form.
negate() - Method in class org.apache.commons.math.fraction.Fraction
Return the additive inverse of this fraction.
negate() - Method in class org.apache.commons.math.geometry.Vector3D
Get the opposite of the instance.
NEGATIVE_INFINITY - Static variable in class org.apache.commons.math.geometry.Vector3D
A vector with all coordinates set to negative infinity.
NegativeBinomial - Class in cern.jet.random
Negative Binomial distribution; See the math definition.
NegativeBinomial(int, double, RandomEngine) - Constructor for class cern.jet.random.NegativeBinomial
Constructs a Negative Binomial distribution.
NegativeBinomial - Class in cern.jet.random.tdouble
Negative Binomial distribution; See the math definition.
NegativeBinomial(int, double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.NegativeBinomial
Constructs a Negative Binomial distribution.
negativeBinomial(int, int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the terms 0 through k of the Negative Binomial Distribution.
negativeBinomial(int, int, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the sum of the terms 0 through k of the Negative Binomial Distribution.
NegativeBinomial - Class in jhplot.fit
Negative binomial distribution.
NegativeBinomial() - Constructor for class jhplot.fit.NegativeBinomial
 
NegativeBinomial(String) - Constructor for class jhplot.fit.NegativeBinomial
 
NegativeBinomial(String[], String[]) - Constructor for class jhplot.fit.NegativeBinomial
 
NegativeBinomial - Class in jhplot.math.num.pdf
The Negative Binomial distribution.
NegativeBinomial() - Constructor for class jhplot.math.num.pdf.NegativeBinomial
Default constructor.
NegativeBinomial(int, double) - Constructor for class jhplot.math.num.pdf.NegativeBinomial
Create a distribution with the given number of successes and probability of success.
negativeBinomialComplemented(int, int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the terms k+1 to infinity of the Negative Binomial distribution.
negativeBinomialComplemented(int, int, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the sum of the terms k+1 to infinity of the Negative Binomial distribution.
NegativeBinomialDist - Class in umontreal.iro.lecuyer.probdist
Extends the class DiscreteDistributionInt for the negative binomial distribution with real parameters γ and p, where γ > 0 and 0 <= p <= 1.
NegativeBinomialDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Creates an object that contains the probability terms and the distribution function for the negative binomial distribution with parameters γ and p.
NegativeBinomialGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators having the negative binomial distribution.
NegativeBinomialGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.NegativeBinomialGen
Creates a negative binomial random variate generator with parameters γ = gamma and p, using stream s.
NegativeBinomialGen(RandomStream, NegativeBinomialDist) - Constructor for class umontreal.iro.lecuyer.randvar.NegativeBinomialGen
Creates a new generator for the distribution dist, using stream s.
NegativeBinomialRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Negative Binomial distribution.
NegativeBinomialRandomVariable() - Constructor for class jhplot.math.num.random.NegativeBinomialRandomVariable
Default constructor.
NegativeBinomialRandomVariable(int, double) - Constructor for class jhplot.math.num.random.NegativeBinomialRandomVariable
Create a random variable with the given number of successes and probability of success.
NegativeBinomialRandomVariable(int, double, RNG) - Constructor for class jhplot.math.num.random.NegativeBinomialRandomVariable
Create a random variable with the given parameters.
NegativeMultinomialDist - Class in umontreal.iro.lecuyer.probdistmulti
Implements the abstract class DiscreteDistributionIntMulti for the negative multinomial distribution with parameters γ > 0 and ( p1,…, pd), such that all 0 < pi < 1 and i=1dpi < 1.
NegativeMultinomialDist(double, double[]) - Constructor for class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Creates a NegativeMultinomialDist object with parameters γ = gamma and (p1,...,pd) such that i=1dpi < 1, as described above.
nEigenOneOrGreater() - Method in class flanagan.analysis.PCA
 
nelderMead(MaximizationFunction, double[], double[], double, int) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximisationFunction, double[], double[], double, int) - Method in class flanagan.math.Maximisation
 
nelderMead(Object, double[], double[], double, int) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximizationFunction, double[], double[], double) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximisationFunction, double[], double[], double) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximizationFunction, double[], double[], int) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximisationFunction, double[], double[], int) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximizationFunction, double[], double[]) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximisationFunction, double[], double[]) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximizationFunction, double[], double, int) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximisationFunction, double[], double, int) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximizationFunction, double[], double) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximisationFunction, double[], double) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximizationFunction, double[], int) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximisationFunction, double[], int) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximizationFunction, double[]) - Method in class flanagan.math.Maximisation
 
nelderMead(MaximisationFunction, double[]) - Method in class flanagan.math.Maximisation
 
nelderMead(MinimisationFunction, double[], double[], double, int) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimizationFunction, double[], double[], double, int) - Method in class flanagan.math.Minimisation
 
nelderMead(Object, double[], double[], double, int) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimisationFunction, double[], double[], double) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimizationFunction, double[], double[], double) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimisationFunction, double[], double[], int) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimizationFunction, double[], double[], int) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimisationFunction, double[], double[]) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimizationFunction, double[], double[]) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimisationFunction, double[], double, int) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimizationFunction, double[], double, int) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimisationFunction, double[], double) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimizationFunction, double[], double) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimisationFunction, double[], int) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimizationFunction, double[], int) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimisationFunction, double[]) - Method in class flanagan.math.Minimisation
 
nelderMead(MinimizationFunction, double[]) - Method in class flanagan.math.Minimisation
 
NelderMead - Class in org.apache.commons.math.optimization.direct
This class implements the Nelder-Mead direct search method.
NelderMead() - Constructor for class org.apache.commons.math.optimization.direct.NelderMead
Build a Nelder-Mead optimizer with default coefficients.
NelderMead(double, double, double, double) - Constructor for class org.apache.commons.math.optimization.direct.NelderMead
Build a Nelder-Mead optimizer with specified coefficients.
netlib() - Method in enum cern.colt.matrix.Transpose
 
neutron_mass_c2 - Static variable in class cern.clhep.PhysicalConstants
 
NevilleInterpolator - Class in org.apache.commons.math.analysis.interpolation
Implements the Neville's Algorithm for interpolation of real univariate functions.
NevilleInterpolator() - Constructor for class org.apache.commons.math.analysis.interpolation.NevilleInterpolator
 
newArrayOfObservations(ListOfStatProbes<?>, double[]) - Method in interface umontreal.iro.lecuyer.stat.list.ArrayOfObservationListener
Receives the new array of observations x broadcast by the list of statistical probes listOfProbes.
newBisectionSolver() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactory
Create a new UnivariateRealSolver.
newBisectionSolver() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactoryImpl
Create a new UnivariateRealSolver.
newBrentSolver() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactory
Create a new UnivariateRealSolver.
newBrentSolver() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactoryImpl
Create a new UnivariateRealSolver.
newDefaultSolver() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactory
Create a new UnivariateRealSolver.
newDefaultSolver() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactoryImpl
Create a new UnivariateRealSolver.
newDfp() - Method in class org.apache.commons.math.dfp.DfpField
Makes a Dfp with a value of 0.
newDfp(byte) - Method in class org.apache.commons.math.dfp.DfpField
Create an instance from a byte value.
newDfp(int) - Method in class org.apache.commons.math.dfp.DfpField
Create an instance from an int value.
newDfp(long) - Method in class org.apache.commons.math.dfp.DfpField
Create an instance from a long value.
newDfp(double) - Method in class org.apache.commons.math.dfp.DfpField
Create an instance from a double value.
newDfp(Dfp) - Method in class org.apache.commons.math.dfp.DfpField
Copy constructor.
newDfp(String) - Method in class org.apache.commons.math.dfp.DfpField
Create a Dfp given a String representation.
newDfp(byte, byte) - Method in class org.apache.commons.math.dfp.DfpField
Creates a Dfp with a non-finite value.
newDoubleQuantileFinder(boolean, long, double, double, int, RandomEngine) - Static method in class cern.jet.stat.quantile.QuantileFinderFactory
Returns a quantile finder that minimizes the amount of memory needed under the user provided constraints.
newDoubleQuantileFinder(boolean, long, double, double, int, DoubleRandomEngine) - Static method in class cern.jet.stat.tdouble.quantile.DoubleQuantileFinderFactory
Returns a quantile finder that minimizes the amount of memory needed under the user provided constraints.
newEquiDepthPhis(int) - Static method in class cern.jet.stat.quantile.QuantileFinderFactory
Convenience method that computes phi's for equi-depth histograms.
newEquiDepthPhis(int) - Static method in class cern.jet.stat.tdouble.quantile.DoubleQuantileFinderFactory
Convenience method that computes phi's for equi-depth histograms.
newEquiDepthPhis(int) - Static method in class cern.jet.stat.tfloat.quantile.FloatQuantileFinderFactory
Convenience method that computes phi's for equi-depth histograms.
newFixedLengthChromosome(List<T>) - Method in class org.apache.commons.math.genetics.AbstractListChromosome
Creates a new instance of the same class as this is, with a given arrayRepresentation.
newFloatQuantileFinder(boolean, long, float, float, int, FloatRandomEngine) - Static method in class cern.jet.stat.tfloat.quantile.FloatQuantileFinderFactory
Returns a quantile finder that minimizes the amount of memory needed under the user provided constraints.
newInstance() - Static method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactory
Create a new factory.
newInstance() - Method in class org.apache.commons.math.dfp.Dfp
Create an instance with a value of 0.
newInstance(byte) - Method in class org.apache.commons.math.dfp.Dfp
Create an instance from a byte value.
newInstance(int) - Method in class org.apache.commons.math.dfp.Dfp
Create an instance from an int value.
newInstance(long) - Method in class org.apache.commons.math.dfp.Dfp
Create an instance from a long value.
newInstance(double) - Method in class org.apache.commons.math.dfp.Dfp
Create an instance from a double value.
newInstance(Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Create an instance by copying an existing one.
newInstance(String) - Method in class org.apache.commons.math.dfp.Dfp
Create an instance from a String representation.
newInstance(byte, byte) - Method in class org.apache.commons.math.dfp.Dfp
Creates an instance with a non-finite value.
newInstance() - Method in class org.apache.commons.math.dfp.DfpDec
Create an instance with a value of 0.
newInstance(byte) - Method in class org.apache.commons.math.dfp.DfpDec
Create an instance from a byte value.
newInstance(int) - Method in class org.apache.commons.math.dfp.DfpDec
Create an instance from an int value.
newInstance(long) - Method in class org.apache.commons.math.dfp.DfpDec
Create an instance from a long value.
newInstance(double) - Method in class org.apache.commons.math.dfp.DfpDec
Create an instance from a double value.
newInstance(Dfp) - Method in class org.apache.commons.math.dfp.DfpDec
Create an instance by copying an existing one.
newInstance(String) - Method in class org.apache.commons.math.dfp.DfpDec
Create an instance from a String representation.
newInstance(byte, byte) - Method in class org.apache.commons.math.dfp.DfpDec
Creates an instance with a non-finite value.
newInstance() - Method in class umontreal.iro.lecuyer.rng.BasicRandomStreamFactory
 
newInstance() - Method in interface umontreal.iro.lecuyer.rng.RandomStreamFactory
Constructs and returns a new random stream.
newInstance() - Static method in class umontreal.iro.lecuyer.simprocs.ProcessSimulator
Constructs and returns a new process-oriented simulator.
newInternalCursor() - Method in class hep.aida.ref.tuple.AbstractTuple
 
NEWLINE - Static variable in class umontreal.iro.lecuyer.util.PrintfFormat
End-of-line symbol or line separator.
newNewtonSolver() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactory
Create a new UnivariateRealSolver.
newNewtonSolver() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactoryImpl
Create a new UnivariateRealSolver.
newObservation(StatProbe, double) - Method in interface umontreal.iro.lecuyer.stat.ObservationListener
Receives the new observation x broadcast by probe.
newSampleData(double[], int, int) - Method in class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
Loads model x and y sample data from a flat input array, overriding any previous sample.
newSampleData(double[], double[][], double[][]) - Method in class org.apache.commons.math.stat.regression.GLSMultipleLinearRegression
Replace sample data, overriding any previous sample.
newSampleData(double[], double[][]) - Method in class org.apache.commons.math.stat.regression.OLSMultipleLinearRegression
Loads model x and y sample data, overriding any previous sample.
newSampleData(double[], int, int) - Method in class org.apache.commons.math.stat.regression.OLSMultipleLinearRegression
Loads model x and y sample data from a flat input array, overriding any previous sample.
newSecantSolver() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactory
Create a new UnivariateRealSolver.
newSecantSolver() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactoryImpl
Create a new UnivariateRealSolver.
newton - Static variable in class cern.clhep.Units
 
NewtonRootFinder - Class in jhplot.math.num.root
Newton's method (1) for finding roots of functions.
NewtonRootFinder(Function, Function) - Constructor for class jhplot.math.num.root.NewtonRootFinder
Create a root finder for the given function.
NewtonRootFinder(Function, Function, int, double) - Constructor for class jhplot.math.num.root.NewtonRootFinder
Create a root finder for the given function.
NewtonSolver - Class in org.apache.commons.math.analysis.solvers
Implements Newton's Method for finding zeros of real univariate functions.
NewtonSolver(DifferentiableUnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.solvers.NewtonSolver
Deprecated. as of 2.0 the function to solve is passed as an argument to the NewtonSolver.solve(UnivariateRealFunction, double, double) or UnivariateRealSolver.solve(UnivariateRealFunction, double, double, double) method.
NewtonSolver() - Constructor for class org.apache.commons.math.analysis.solvers.NewtonSolver
Deprecated. in 2.2 (to be removed in 3.0).
newYearsDay() - Method in class flanagan.math.TimeAndDate
 
newYearsDay(int) - Method in class flanagan.math.TimeAndDate
 
next() - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
next() - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Increases iteration counter
next() - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
next() - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Increases iteration counter
next() - Method in class hep.aida.ref.fitter.fitdata.FitDataIterator
 
next() - Method in class hep.aida.ref.tuple.AbstractTuple
 
next() - Method in class hep.aida.ref.tuple.ChainedTuple
Positions the cursor at the next row.
next() - Method in interface hep.aida.ref.tuple.FTupleCursor
 
next() - Method in class hep.aida.ref.tuple.TupleCursor
 
next() - Method in class jhplot.io.csv.CSVReader
Reads the next line from the buffer and converts to a string List.
next() - Method in class jhplot.math.Poisson
Get next Poisson random number with the lambda given in constructor
next(double) - Method in class jhplot.math.Poisson
Get next Poisson random number with a new lambda (overwrides the default)
next() - Method in class org.apache.commons.math.util.MultidimensionalCounter.Iterator
 
nextAfter(Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Returns the next number greater than this one in the direction of x.
nextAfter(Dfp) - Method in class org.apache.commons.math.dfp.DfpDec
Returns the next number greater than this one in the direction of x.
nextAfter(double, double) - Static method in class org.apache.commons.math.util.FastMath
Get the next machine representable number after a number, moving in the direction of another number.
nextAfter(float, double) - Static method in class org.apache.commons.math.util.FastMath
Get the next machine representable number after a number, moving in the direction of another number.
nextAfter(double, double) - Static method in class org.apache.commons.math.util.MathUtils
Deprecated. as of 2.2, replaced by FastMath.nextAfter(double, double) which handles Infinities differently, and returns direction if d and direction compare equal.
nextArrayOfDouble(double[], int, int) - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGen
Generates n random numbers from the continuous distribution contained in this object.
nextArrayOfDouble(double[], int, int) - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
 
nextArrayOfDouble(double[], int, int) - Method in class umontreal.iro.lecuyer.randvar.UnuranContinuous
 
nextArrayOfDouble(double[], int, int) - Method in class umontreal.iro.lecuyer.randvar.UnuranEmpirical
 
nextArrayOfDouble(double[], int, int) - Method in class umontreal.iro.lecuyer.rng.AntitheticStream
Calls nextArrayOfDouble (u, start, n) for the base stream, then replaces each u[i] by 1.0 - u[i].
nextArrayOfDouble(double[], int, int) - Method in class umontreal.iro.lecuyer.rng.BakerTransformedStream
Calls nextArrayOfDouble (u, start, n) for the base stream, then applies the baker transformation.
nextArrayOfDouble(double[], int, int) - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated.  
nextArrayOfDouble(double[], int, int) - Method in interface umontreal.iro.lecuyer.rng.RandomStream
Generates n (pseudo)random numbers from the uniform distribution and stores them into the array u starting at index start.
nextArrayOfDouble(double[], int, int) - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
Calls nextDouble n times to fill the array u.
nextArrayOfDouble(double[], int, int) - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
 
nextArrayOfDouble(double[], int, int) - Method in class umontreal.iro.lecuyer.rng.TruncatedRandomStream
 
nextArrayOfInt(int[], int, int) - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenInt
Generates n random numbers from the discrete distribution contained in this object.
nextArrayOfInt(int[], int, int) - Method in class umontreal.iro.lecuyer.randvar.UnuranDiscreteInt
 
nextArrayOfInt(int, int, int[], int, int) - Method in class umontreal.iro.lecuyer.rng.AntitheticStream
Calls nextArrayOfInt (i, j, u, start, n) for the base stream, then replaces each u[i] by j - i - u[i].
nextArrayOfInt(int, int, int[], int, int) - Method in class umontreal.iro.lecuyer.rng.BakerTransformedStream
Fills up the array by calling nextInt (i, j).
nextArrayOfInt(int, int, int[], int, int) - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated.  
nextArrayOfInt(int, int, int[], int, int) - Method in interface umontreal.iro.lecuyer.rng.RandomStream
Generates n (pseudo)random numbers from the discrete uniform distribution over the integers {i, i + 1,..., j}, using this stream and stores the result in the array u starting at index start.
nextArrayOfInt(int, int, int[], int, int) - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
Calls nextInt n times to fill the array u.
nextArrayOfInt(int, int, int[], int, int) - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
 
nextArrayOfInt(int, int, int[], int, int) - Method in class umontreal.iro.lecuyer.rng.TruncatedRandomStream
 
nextArrayOfPoints(double[][], int, int) - Method in class umontreal.iro.lecuyer.randvarmulti.RandomMultivariateGen
Generates n random points.
nextBeta(double, double) - Method in class flanagan.math.PsRandom
 
nextBeta(double, double, double, double) - Method in class flanagan.math.PsRandom
 
nextBeta(double, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the Beta Distribution.
nextBinomial(double, int) - Method in class flanagan.math.PsRandom
 
nextBinomial(int, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the Binomial Distribution.
nextBit() - Method in class flanagan.math.PsRandom
 
nextBitM1() - Method in class flanagan.math.PsRandom
 
nextBitM2() - Method in class flanagan.math.PsRandom
 
nextBlock(int, long[], int) - Method in class cern.jet.random.sampling.RandomSampler
Computes the next count random numbers of the sorted random set specified on instance construction and fills them into values, starting at index fromIndex.
nextBlock(int, long[], int) - Method in class cern.jet.random.tdouble.sampling.DoubleRandomSampler
Computes the next count random numbers of the sorted random set specified on instance construction and fills them into values, starting at index fromIndex.
nextBlock(int, long[], int) - Method in class cern.jet.random.tfloat.sampling.FloatRandomSampler
Computes the next count random numbers of the sorted random set specified on instance construction and fills them into values, starting at index fromIndex.
nextBoolean() - Method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random boolean.
nextBoolean() - Method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random boolean.
nextBoolean() - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random boolean.
nextBoolean() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in class org.apache.commons.math.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBoolean() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed boolean value from this random number generator's sequence.
nextBstClockChange() - Method in class flanagan.math.TimeAndDate
 
nextBurr1(double, int, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a random number from the Burr II, VII, VIII, X Distributions.
nextBurr1(double, int, DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a random number from the Burr II, VII, VIII, X Distributions.
nextBurr2(double, double, int, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a random number from the Burr III, IV, V, VI, IX, XII distributions.
nextBurr2(double, double, int, DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a random number from the Burr III, IV, V, VI, IX, XII distributions.
nextBytes(byte[]) - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in class org.apache.commons.math.random.BitsStreamGenerator
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in class org.apache.commons.math.random.RandomAdaptor
Generates random bytes and places them into a user-supplied byte array.
nextBytes(byte[]) - Method in interface org.apache.commons.math.random.RandomGenerator
Generates random bytes and places them into a user-supplied byte array.
nextCauchy(RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a cauchy distributed random number from the standard Cauchy distribution C(0,1).
nextCauchy(DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a cauchy distributed random number from the standard Cauchy distribution C(0,1).
nextCauchy(double, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the Cauchy Distribution.
nextChiSquare(int) - Method in class flanagan.math.PsRandom
 
nextChiSquare(double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the ChiSquare Distribution.
nextCoordinate() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
nextCoordinate() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2.CycleBasedPointSetBase2Iterator
 
nextCoordinate() - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Returns the current coordinate ui, j and advances to the next one.
nextCoordinates(double[], int) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
nextCoordinates(double[], int) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2.CycleBasedPointSetBase2Iterator
 
nextCoordinates(double[], int) - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Returns the next d coordinates of the current point in p and advances the current coordinate index by d.
nextDouble() - Method in class cern.jet.random.AbstractDiscreteDistribution
Returns a random number from the distribution; returns (double) nextInt().
nextDouble() - Method in class cern.jet.random.AbstractDistribution
Returns a random number from the distribution.
nextDouble() - Method in class cern.jet.random.Beta
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.Beta
Returns a beta distributed random number; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.BreitWigner
Returns a random number from the distribution.
nextDouble(double, double, double) - Method in class cern.jet.random.BreitWigner
Returns a random number from the distribution; bypasses the internal state.
nextDouble(double, double, double) - Method in class cern.jet.random.BreitWignerMeanSquare
Returns a mean-squared random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.ChiSquare
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.ChiSquare
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Empirical
Returns a random number from the distribution.
nextDouble() - Method in class cern.jet.random.engine.RandomEngine
Returns a 64 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
nextDouble() - Method in interface cern.jet.random.engine.RandomGenerator
Returns a 64 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
nextDouble() - Method in class cern.jet.random.Exponential
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.Exponential
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.ExponentialPower
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.ExponentialPower
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Gamma
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.Gamma
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Hyperbolic
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.Hyperbolic
Returns a hyperbolic distributed random number; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Logarithmic
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.Logarithmic
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Normal
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.Normal
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.StudentT
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.StudentT
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.AbstractDiscreteDistribution
Returns a random number from the distribution; returns (double) nextInt().
nextDouble() - Method in class cern.jet.random.tdouble.AbstractDoubleDistribution
Returns a random number from the distribution.
nextDouble() - Method in class cern.jet.random.tdouble.Beta
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.tdouble.Beta
Returns a beta distributed random number; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.BreitWigner
Returns a random number from the distribution.
nextDouble(double, double, double) - Method in class cern.jet.random.tdouble.BreitWigner
Returns a random number from the distribution; bypasses the internal state.
nextDouble(double, double, double) - Method in class cern.jet.random.tdouble.BreitWignerMeanSquare
Returns a mean-squared random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.ChiSquare
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.tdouble.ChiSquare
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the open interval (min,max) (excluding min and max).
nextDouble() - Method in class cern.jet.random.tdouble.Empirical
Returns a random number from the distribution.
nextDouble() - Method in class cern.jet.random.tdouble.engine.DoubleRandomEngine
Returns a 64 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
nextDouble() - Method in interface cern.jet.random.tdouble.engine.RandomGenerator
Returns a 64 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
nextDouble() - Method in class cern.jet.random.tdouble.Exponential
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.tdouble.Exponential
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.ExponentialPower
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.tdouble.ExponentialPower
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.Gamma
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.tdouble.Gamma
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.Hyperbolic
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.tdouble.Hyperbolic
Returns a hyperbolic distributed random number; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.Logarithmic
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.tdouble.Logarithmic
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.Normal
Returns a random number from the distribution.
nextDouble(double, double) - Method in class cern.jet.random.tdouble.Normal
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.StudentT
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.tdouble.StudentT
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.tdouble.VonMises
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.tdouble.VonMises
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (min,max) (excluding min and max).
nextDouble() - Method in class cern.jet.random.VonMises
Returns a random number from the distribution.
nextDouble(double) - Method in class cern.jet.random.VonMises
Returns a random number from the distribution; bypasses the internal state.
nextDouble() - Method in class flanagan.math.PsRandom
 
nextDouble(double) - Method in class flanagan.math.PsRandom
 
nextDouble(double, double) - Method in class flanagan.math.PsRandom
 
nextDouble() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in class org.apache.commons.math.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed double value between 0.0 and 1.0 from this random number generator's sequence.
nextDouble() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
nextDouble(RandomStream, double, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.BetaGen
Generates a variate from the beta distribution with parameters α = alpha, β = beta, over the interval (a, b), using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.BetaRejectionLoglogisticGen
 
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.BetaStratifiedRejectionGen
 
nextDouble(RandomStream, double, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.BetaStratifiedRejectionGen
 
nextDouble(RandomStream, RandomStream, RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.BetaSymmetricalBestGen
Generates a random number using Devroye's one-liner method.
nextDouble(RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.BetaSymmetricalBestGen
Generates a random number using Devroye's one-liner method with only one stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.BetaSymmetricalBestGen
 
nextDouble(RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.BetaSymmetricalGen
 
nextDouble(RandomStream, RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.BetaSymmetricalPolarGen
Generates a random number using Ulrich's polar method.
nextDouble(RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.BetaSymmetricalPolarGen
Generates a random number by Ulrich's polar method using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.BetaSymmetricalPolarGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.CauchyGen
Generates a new variate from the Cauchy distribution with parameters α = alpha and β = beta, using stream s.
nextDouble(RandomStream, int) - Static method in class umontreal.iro.lecuyer.randvar.ChiGen
Generates a random variate from the chi distribution with ν = nu degrees of freedom, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.ChiRatioOfUniformsGen
 
nextDouble(RandomStream, int) - Static method in class umontreal.iro.lecuyer.randvar.ChiRatioOfUniformsGen
 
nextDouble(RandomStream, int) - Static method in class umontreal.iro.lecuyer.randvar.ChiSquareGen
Generates a new variate from the chi square distribution with n degrees of freedom, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralGamGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralGamGen
Generates a variate from the noncentral chi square distribution with parameters ν = nu and λ = lambda using stream stream, as described above.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralGen
Generates a new variate from the noncentral chi square distribution with ν degrees of freedom and noncentrality parameter λ, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralPoisGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.ChiSquareNoncentralPoisGen
Generates a variate from the noncentral chi square distribution with parameters ν = nu and λ = lambda using stream stream, as described above.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.ErlangConvolutionGen
 
nextDouble(RandomStream, int, double) - Static method in class umontreal.iro.lecuyer.randvar.ErlangConvolutionGen
 
nextDouble(RandomStream, int, double) - Static method in class umontreal.iro.lecuyer.randvar.ErlangGen
Generates a new variate from the Erlang distribution with parameters k = k and λ = lambda, using stream s.
nextDouble(RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.ExponentialGen
Uses inversion to generate a new exponential variate with parameter λ = lambda, using stream s.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.ExtremeValueGen
Deprecated. Uses inversion to generate a new variate from the extreme value distribution with parameters α = alpha and λ = lambda, using stream s.
nextDouble(RandomStream, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.FatigueLifeGen
Generates a variate from the fatigue life distribution with location parameter μ, scale parameter β and shape parameter γ.
nextDouble(RandomStream, int, int) - Static method in class umontreal.iro.lecuyer.randvar.FisherFGen
Generates a variate from the Fisher F distribution with n and m degrees of freedom, using stream s.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.FoldedNormalGen
Generates a variate from the folded normal distribution with parameters μ = mu and σ = sigma, using stream s.
nextDouble(RandomStream, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.FrechetGen
Generates a new variate from the Fréchet distribution with parameters α = alpha, β = beta and δ = delta using stream s.
nextDouble(RandomStream, RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.GammaAcceptanceRejectionGen
Generates a new gamma variate with parameters α = alpha and λ = lambda, using main stream s and auxiliary stream aux.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.GammaAcceptanceRejectionGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.GammaAcceptanceRejectionGen
Same as nextDouble (s, s, alpha, lambda).
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.GammaGen
Generates a new gamma random variate with parameters α = alpha and λ = lambda, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.GammaRejectionLoglogisticGen
 
nextDouble(RandomStream, RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.GammaRejectionLoglogisticGen
Generates a new gamma variate with parameters α = alpha and λ = lambda, using main stream s and auxiliary stream aux.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.GammaRejectionLoglogisticGen
Same as nextDouble (s, s, alpha, lambda).
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.GumbelGen
Generates a new variate from the Gumbel distribution with parameters β = beta and δ = delta using stream s.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.HalfNormalGen
Generates a variate from the half-normal distribution with parameters μ = mu and σ = sigma, using stream s.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.HyperbolicSecantGen
Generates a variate from the hyperbolic secant distribution with location parameter μ and scale parameter σ.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.InverseFromDensityGen
Generates a new random variate.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.InverseGammaGen
Generates a variate from the inverse gamma distribution with shape parameter α > 0 and scale parameter β > 0.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.InverseGaussianGen
Generates a variate from the inverse gaussian distribution with location parameter μ > 0 and scale parameter λ > 0.
nextDouble(RandomStream, NormalGen, double, double) - Static method in class umontreal.iro.lecuyer.randvar.InverseGaussianMSHGen
Generates a new variate from the inverse gaussian distribution with parameters μ = mu and λ = lambda, using streams s and sn.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.InverseGaussianMSHGen
 
nextDouble(RandomStream, double, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.JohnsonSBGen
Uses inversion to generate a new JohnsonSB variate, using stream s.
nextDouble(RandomStream, double, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.JohnsonSUGen
Uses inversion to generate a new JohnsonSU variate, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.KernelDensityGen
 
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.KernelDensityVarCorrectGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.LogisticGen
Generates a new variate from the logistic distribution with parameters α = alpha and λ = lambda, using stream s.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.LoglogisticGen
Generates a variate from the log-logistic distribution with shape parameter α > 0 and scale parameter β > 0.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.LognormalGen
Generates a new variate from the lognormal distribution with parameters μ = mu and σ = sigma, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.LognormalSpecialGen
 
nextDouble(RandomStream, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.NakagamiGen
Generates a variate from the Nakagami distribution with parameters a = a, λ = lambda and c = c, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.NormalACRGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.NormalACRGen
 
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.NormalBoxMullerGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.NormalBoxMullerGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.NormalGen
Generates a variate from the normal distribution with parameters μ = mu and σ = sigma, using stream s.
nextDouble(RandomStream, double, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.NormalInverseGaussianGen
NOT IMPLEMENTED.
nextDouble(InverseGaussianGen, NormalGen, double, double) - Static method in class umontreal.iro.lecuyer.randvar.NormalInverseGaussianIGGen
Generates a new variate from the distribution with parameters α, β = beta, μ = mu and δ, using generators ig and ng, as described in eq..
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.NormalInverseGaussianIGGen
 
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.NormalKindermannRamageGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.NormalKindermannRamageGen
 
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.NormalPolarGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.NormalPolarGen
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.ParetoGen
Generates a new variate from the Pareto distribution with parameters α = alpha and β = beta, using stream s.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.Pearson5Gen
Generates a variate from the Pearson V distribution with shape parameter α > 0 and scale parameter β > 0.
nextDouble(RandomStream, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.Pearson6Gen
Generates a variate from the Pearson VI distribution with shape parameters α1 > 0 and α2 > 0, and scale parameter β > 0.
nextDouble(RandomStream, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.PowerGen
Uses inversion to generate a new variate from the power distribution with parameters a = a, b = b, and c = c, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGen
Generates a random number from the continuous distribution contained in this object.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
 
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.RayleighGen
Uses inversion to generate a new variate from the Rayleigh distribution with parameters a = a and β = beta, using stream s.
nextDouble(RandomStream, int) - Static method in class umontreal.iro.lecuyer.randvar.StudentGen
Generates a new variate from the Student distribution with n = n degrees of freedom, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.StudentPolarGen
 
nextDouble(RandomStream, int) - Static method in class umontreal.iro.lecuyer.randvar.StudentPolarGen
 
nextDouble(RandomStream, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.TriangularGen
Generates a new variate from the triangular distribution with parameters a = a, b = b and m = m and stream s, using inversion.
nextDouble(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.UniformGen
Generates a uniform random variate over the interval (a, b) by inversion, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.UnuranContinuous
 
nextDouble() - Method in class umontreal.iro.lecuyer.randvar.UnuranEmpirical
 
nextDouble(RandomStream, double, double, double) - Static method in class umontreal.iro.lecuyer.randvar.WeibullGen
Uses inversion to generate a new variate from the Weibull distribution with parameters α = alpha, λ = lambda, and δ = delta, using stream s.
nextDouble() - Method in class umontreal.iro.lecuyer.rng.AntitheticStream
Returns 1.0 - s.nextDouble() where s is the base stream.
nextDouble() - Method in class umontreal.iro.lecuyer.rng.BakerTransformedStream
Returns the baker transformation of s.nextDouble() where s is the base stream.
nextDouble() - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated. Returns a (pseudo)random number from the uniform distribution over the interval (0, 1), using this stream, after advancing its state by one step.
nextDouble() - Method in interface umontreal.iro.lecuyer.rng.RandomStream
Returns a (pseudo)random number from the uniform distribution over the interval (0, 1), using this stream, after advancing its state by one step.
nextDouble() - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
Returns a uniform random number between 0 and 1 from the stream.
nextDouble() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
 
nextDouble() - Method in class umontreal.iro.lecuyer.rng.TruncatedRandomStream
 
nextDoubleFromTo(double, double) - Method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
nextDoubleFromTo(double, double) - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
nextErlang(double, double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns an erlang distributed random number with the given variance and mean.
nextErlang(double, double, DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns an erlang distributed random number with the given variance and mean.
nextErlang(double, int) - Method in class flanagan.math.PsRandom
 
nextExponential(double, double) - Method in class flanagan.math.PsRandom
 
nextExponential(double) - Method in interface org.apache.commons.math.random.RandomData
Generates a random value from the exponential distribution with expected value = mean.
nextExponential(double) - Method in class org.apache.commons.math.random.RandomDataImpl
Returns a random value from an Exponential distribution with the given mean.
nextF(int, int) - Method in class flanagan.math.PsRandom
 
nextF(double, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the F Distribution.
nextFloat() - Method in class cern.jet.random.engine.RandomEngine
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0f,1.0f) (excluding 0.0f and 1.0f).
nextFloat() - Method in interface cern.jet.random.engine.RandomGenerator
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0f,1.0f) (excluding 0.0f and 1.0f).
nextFloat() - Method in class cern.jet.random.tdouble.engine.DoubleRandomEngine
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0f,1.0f) (excluding 0.0f and 1.0f).
nextFloat() - Method in interface cern.jet.random.tdouble.engine.RandomGenerator
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0f,1.0f) (excluding 0.0f and 1.0f).
nextFloat() - Method in class cern.jet.random.tfloat.AbstractFloatDistribution
Returns a random number from the distribution.
nextFloat() - Method in class cern.jet.random.tfloat.engine.FloatRandomEngine
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0f,1.0f) (excluding 0.0f and 1.0f).
nextFloat() - Method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random number in the open interval (min,max) (excluding min and max).
nextFloat() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in class org.apache.commons.math.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloat() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed float value between 0.0 and 1.0 from this random number generator's sequence.
nextFloatFromTo(float, float) - Method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
nextFloatFromTo(float, float) - Method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
nextFloatFromTo(float, float) - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
nextFrechet(double, double, double) - Method in class flanagan.math.PsRandom
 
nextGamma(double, double, double) - Method in class flanagan.math.PsRandom
 
nextGamma(double, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the Gamma Distribution.
nextGaussian(double, double) - Method in class flanagan.math.PsRandom
 
nextGaussian() - Method in class flanagan.math.PsRandom
 
nextGaussian() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian() - Method in class org.apache.commons.math.random.BitsStreamGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGaussian(double, double) - Method in interface org.apache.commons.math.random.RandomData
Generates a random value from the Normal (or Gaussian) distribution with the given mean and standard deviation.
nextGaussian(double, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random value from a Normal (a.k.a.
nextGaussian() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, Gaussian ("normally") distributed double value with mean 0.0 and standard deviation 1.0 from this random number generator's sequence.
nextGeneration() - Method in class org.apache.commons.math.genetics.ElitisticListPopulation
Start the population for the next generation.
nextGeneration(Population) - Method in class org.apache.commons.math.genetics.GeneticAlgorithm
Evolve the given population into the next generation.
nextGeneration() - Method in interface org.apache.commons.math.genetics.Population
Start the population for the next generation.
nextGeometric(double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a discrete geometric distributed random number; Definition.
nextGeometric(double, DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a discrete geometric distributed random number; Definition.
nextHexString(int) - Method in interface org.apache.commons.math.random.RandomData
Generates a random string of hex characters of length len.
nextHexString(int) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random string of hex characters of length len.
nextHypergeometric(int, int, int) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the Hypergeometric Distribution.
nextInt() - Method in class cern.jet.random.AbstractDiscreteDistribution
Returns a random number from the distribution.
nextInt() - Method in class cern.jet.random.AbstractDistribution
Returns a random number from the distribution; returns (int) Math.round(nextDouble()).
nextInt() - Method in class cern.jet.random.Binomial
Returns a random number from the distribution.
nextInt(int, double) - Method in class cern.jet.random.Binomial
Returns a random number from the distribution with the given parameters n and p; bypasses the internal state.
nextInt() - Method in class cern.jet.random.EmpiricalWalker
Returns a random integer k with probability pdf(k).
nextInt() - Method in class cern.jet.random.engine.DRand
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE).
nextInt() - Method in class cern.jet.random.engine.MersenneTwister
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE).
nextInt() - Method in class cern.jet.random.engine.RandomEngine
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE);
nextInt() - Method in interface cern.jet.random.engine.RandomGenerator
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE);
nextInt() - Method in class cern.jet.random.HyperGeometric
Returns a random number from the distribution.
nextInt(int, int, int) - Method in class cern.jet.random.HyperGeometric
Returns a random number from the distribution; bypasses the internal state.
nextInt() - Method in class cern.jet.random.NegativeBinomial
Returns a random number from the distribution.
nextInt(int, double) - Method in class cern.jet.random.NegativeBinomial
Returns a random number from the distribution; bypasses the internal state.
nextInt() - Method in class cern.jet.random.Poisson
Returns a random number from the distribution.
nextInt(double) - Method in class cern.jet.random.Poisson
Returns a random number from the distribution; bypasses the internal state.
nextInt() - Method in class cern.jet.random.PoissonSlow
Returns a random number from the distribution.
nextInt() - Method in class cern.jet.random.tdouble.AbstractDiscreteDistribution
Returns a random number from the distribution.
nextInt() - Method in class cern.jet.random.tdouble.AbstractDoubleDistribution
Returns a random number from the distribution; returns (int) Math.round(nextDouble()).
nextInt() - Method in class cern.jet.random.tdouble.Binomial
Returns a random number from the distribution.
nextInt(int, double) - Method in class cern.jet.random.tdouble.Binomial
Returns a random number from the distribution with the given parameters n and p; bypasses the internal state.
nextInt() - Method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the closed interval [min,max] (including min and max).
nextInt() - Method in class cern.jet.random.tdouble.EmpiricalWalker
Returns a random integer k with probability pdf(k).
nextInt() - Method in class cern.jet.random.tdouble.engine.DoubleMersenneTwister
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE).
nextInt() - Method in class cern.jet.random.tdouble.engine.DoubleRandomEngine
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE);
nextInt() - Method in class cern.jet.random.tdouble.engine.DRand
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE).
nextInt() - Method in interface cern.jet.random.tdouble.engine.RandomGenerator
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE);
nextInt() - Method in class cern.jet.random.tdouble.HyperGeometric
Returns a random number from the distribution.
nextInt(int, int, int) - Method in class cern.jet.random.tdouble.HyperGeometric
Returns a random number from the distribution; bypasses the internal state.
nextInt() - Method in class cern.jet.random.tdouble.NegativeBinomial
Returns a random number from the distribution.
nextInt(int, double) - Method in class cern.jet.random.tdouble.NegativeBinomial
Returns a random number from the distribution; bypasses the internal state.
nextInt() - Method in class cern.jet.random.tdouble.Poisson
Returns a random number from the distribution.
nextInt(double) - Method in class cern.jet.random.tdouble.Poisson
Returns a random number from the distribution; bypasses the internal state.
nextInt() - Method in class cern.jet.random.tdouble.PoissonSlow
Returns a random number from the distribution.
nextInt() - Method in class cern.jet.random.tdouble.Zeta
Returns a random number from the distribution.
nextInt() - Method in class cern.jet.random.tfloat.AbstractFloatDistribution
Returns a random number from the distribution; returns (int) Math.round(nextFloat()).
nextInt() - Method in class cern.jet.random.tfloat.engine.FloatMersenneTwister
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE).
nextInt() - Method in class cern.jet.random.tfloat.engine.FloatRandomEngine
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE);
nextInt() - Method in class cern.jet.random.tfloat.engine.FRand
Returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE).
nextInt() - Method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random number in the closed interval [min,max] (including min and max).
nextInt() - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the closed interval [min,max] (including min and max).
nextInt() - Method in class cern.jet.random.Zeta
Returns a random number from the distribution.
nextInt() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt() - Method in class org.apache.commons.math.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math.random.BitsStreamGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in class org.apache.commons.math.random.RandomAdaptor
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt(int, int) - Method in interface org.apache.commons.math.random.RandomData
Generates a uniformly distributed random integer between lower and upper (endpoints included).
nextInt(int, int) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random int value uniformly distributed between lower and upper, inclusive.
nextInt() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed int value from this random number generator's sequence.
nextInt(int) - Method in interface org.apache.commons.math.random.RandomGenerator
Returns a pseudorandom, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from this random number generator's sequence.
nextInt(RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.BernoulliGen
Generates a new integer from the Bernoulli distribution with parameter p = p, using the given stream s.
nextInt() - Method in class umontreal.iro.lecuyer.randvar.BinomialConvolutionGen
 
nextInt(RandomStream, int, double) - Static method in class umontreal.iro.lecuyer.randvar.BinomialConvolutionGen
 
nextInt(RandomStream, int, double) - Static method in class umontreal.iro.lecuyer.randvar.BinomialGen
Generates a new integer from the binomial distribution with parameters n = n and p = p, using the given stream s.
nextInt() - Method in class umontreal.iro.lecuyer.randvar.GeometricGen
 
nextInt(RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.GeometricGen
Generates a geometric random variate with parameter p = p, using stream s, by inversion.
nextInt(RandomStream, int, int, int) - Static method in class umontreal.iro.lecuyer.randvar.HypergeometricGen
Generates a new variate from the hypergeometric distribution with parameters m = m, l = l and k = k, using stream s.
nextInt() - Method in class umontreal.iro.lecuyer.randvar.LogarithmicGen
 
nextInt(RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.LogarithmicGen
Uses stream s to generate a new variate from the logarithmic distribution with parameter θ = theta.
nextInt(RandomStream, double, double) - Static method in class umontreal.iro.lecuyer.randvar.NegativeBinomialGen
Generates a new variate from the negative binomial distribution, with parameters γ = gamma and p = p, using stream s.
nextInt() - Method in class umontreal.iro.lecuyer.randvar.PascalConvolutionGen
 
nextInt(RandomStream, int, double) - Static method in class umontreal.iro.lecuyer.randvar.PascalConvolutionGen
 
nextInt(RandomStream, int, double) - Static method in class umontreal.iro.lecuyer.randvar.PascalGen
Generates a new variate from the Pascal distribution, with parameters n = n and p = p, using stream s.
nextInt(RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.PoissonGen
A static method for generating a random variate from a Poisson distribution with parameter λ = lambda.
nextInt() - Method in class umontreal.iro.lecuyer.randvar.PoissonTIACGen
 
nextInt(RandomStream, double) - Static method in class umontreal.iro.lecuyer.randvar.PoissonTIACGen
 
nextInt() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenInt
Generates a random number (an integer) from the discrete distribution contained in this object.
nextInt(RandomStream, int, int) - Static method in class umontreal.iro.lecuyer.randvar.UniformIntGen
Generates a new uniform random variate over the interval [i, j], using stream s, by inversion.
nextInt() - Method in class umontreal.iro.lecuyer.randvar.UnuranDiscreteInt
 
nextInt(int, int) - Method in class umontreal.iro.lecuyer.rng.AntitheticStream
Returns j - i - s.nextInt(i, j) where s is the base stream.
nextInt(int, int) - Method in class umontreal.iro.lecuyer.rng.BakerTransformedStream
Generates a random integer in {i,..., j} via nextDouble (in which the baker transformation is applied).
nextInt(int, int) - Method in class umontreal.iro.lecuyer.rng.LFSR113
 
nextInt(int, int) - Method in class umontreal.iro.lecuyer.rng.LFSR258
 
nextInt(int, int) - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated.  
nextInt(int, int) - Method in interface umontreal.iro.lecuyer.rng.RandomStream
Returns a (pseudo)random number from the discrete uniform distribution over the integers {i, i + 1,..., j}, using this stream.
nextInt(int, int) - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
Calls nextDouble once to create one integer between i and j.
nextInt(int, int) - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
 
nextInt(int, int) - Method in class umontreal.iro.lecuyer.rng.TruncatedRandomStream
 
nextInteger(int) - Method in class flanagan.math.PsRandom
 
nextInteger(int, int) - Method in class flanagan.math.PsRandom
 
nextIntFromTo(int, int) - Method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
nextIntFromTo(int, int) - Method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
nextIntFromTo(int, int) - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
nextInversionDeviate(ContinuousDistribution) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random deviate from the given distribution using the inversion method.
nextInversionDeviate(IntegerDistribution) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random deviate from the given distribution using the inversion method.
nextLambda(double, double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a lambda distributed random number with parameters l3 and l4.
nextLambda(double, double, DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a lambda distributed random number with parameters l3 and l4.
nextLaplace(RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a Laplace (Double Exponential) distributed random number from the standard Laplace distribution L(0,1).
nextLaplace(DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a Laplace (Double Exponential) distributed random number from the standard Laplace distribution L(0,1).
nextLogistic(RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a random number from the standard Logistic distribution Log(0,1).
nextLogistic(DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a random number from the standard Logistic distribution Log(0,1).
nextLogistic(double, double) - Method in class flanagan.math.PsRandom
 
nextLogNormal(double, double) - Method in class flanagan.math.PsRandom
 
nextLogNormalThreePar(double, double, double) - Method in class flanagan.math.PsRandom
 
nextLogNormalTwoPar(double, double) - Method in class flanagan.math.PsRandom
 
nextLong() - Method in class cern.jet.random.engine.RandomEngine
Returns a 64 bit uniformly distributed random number in the closed interval [Long.MIN_VALUE,Long.MAX_VALUE] (including Long.MIN_VALUE and Long.MAX_VALUE).
nextLong() - Method in interface cern.jet.random.engine.RandomGenerator
Returns a 64 bit uniformly distributed random number in the closed interval [Long.MIN_VALUE,Long.MAX_VALUE] (including Long.MIN_VALUE and Long.MAX_VALUE).
nextLong() - Method in class cern.jet.random.tdouble.engine.DoubleRandomEngine
Returns a 64 bit uniformly distributed random number in the closed interval [Long.MIN_VALUE,Long.MAX_VALUE] (including Long.MIN_VALUE and Long.MAX_VALUE).
nextLong() - Method in interface cern.jet.random.tdouble.engine.RandomGenerator
Returns a 64 bit uniformly distributed random number in the closed interval [Long.MIN_VALUE,Long.MAX_VALUE] (including Long.MIN_VALUE and Long.MAX_VALUE).
nextLong() - Method in class cern.jet.random.tfloat.engine.FloatRandomEngine
Returns a 64 bit uniformly distributed random number in the closed interval [Long.MIN_VALUE,Long.MAX_VALUE] (including Long.MIN_VALUE and Long.MAX_VALUE).
nextLong() - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong() - Method in class org.apache.commons.math.random.BitsStreamGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong() - Method in class org.apache.commons.math.random.RandomAdaptor
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLong(long, long) - Method in interface org.apache.commons.math.random.RandomData
Generates a uniformly distributed random long integer between lower and upper (endpoints included).
nextLong(long, long) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random long value uniformly distributed between lower and upper, inclusive.
nextLong() - Method in interface org.apache.commons.math.random.RandomGenerator
Returns the next pseudorandom, uniformly distributed long value from this random number generator's sequence.
nextLongFromTo(long, long) - Method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
nextLongFromTo(long, long) - Method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
nextLongFromTo(long, long) - Method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
nextLorentzian(double, double) - Method in class flanagan.math.PsRandom
 
nextMaximalGumbel(double, double) - Method in class flanagan.math.PsRandom
 
nextMinimalGumbel(double, double) - Method in class flanagan.math.PsRandom
 
nextNormal(double, double) - Method in class flanagan.math.PsRandom
 
nextNormal() - Method in class flanagan.math.PsRandom
 
nextNormalizedDouble() - Method in class org.apache.commons.math.random.GaussianRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextNormalizedDouble() - Method in interface org.apache.commons.math.random.NormalizedRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextNormalizedDouble() - Method in class org.apache.commons.math.random.UniformRandomGenerator
Generate a random scalar with null mean and unit standard deviation.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
 
nextObservation(double) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Generates and returns the next observation at time tj+1 = nextTime.
nextObservation(double, double) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Generates an observation of the process in dt time units, assuming that the process has value x at the current time.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionBridge
 
nextObservation(double) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionBridge
 
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCA
 
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCAEqualSteps
 
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
 
nextObservation(double) - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
Generates and returns the next observation at time tj+1 = nextTime, using the previous observation time tj defined earlier (either by this method or by setObservationTimes), as well as the value of the previous observation X(tj).
nextObservation(double, double) - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
Generates an observation of the process in dt time units, assuming that the process has value x at the current time.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
 
nextObservation(double) - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
Generates and returns the next observation at time tj+1 = nextTime, using the previous observation time tj defined earlier (either by this method or by setObservationTimes), as well as the value of the previous observation X(tj).
nextObservation(double, double) - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
Generates an observation of the process in dt time units, assuming that the process has value x at the current time.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcess
 
nextObservation(double) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcess
Generates and returns the next observation at time tj+1 = nextTime, using the previous observation time tj defined earlier (either by this method or by setObservationTimes), as well as the value of the previous observation X(tj).
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessBridge
 
nextObservation(double) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessBridge
 
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCA
This method is not implemented in this class since the path cannot be generated sequentially.
nextObservation(double) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCA
This method is not implemented in this class since the path cannot be generated sequentially.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessSymmetricalBridge
 
nextObservation(double) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessSymmetricalBridge
 
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
 
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Returns the next observation.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
 
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
 
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessBridge
Returns the next observation in the bridge order, not the sequential order.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
 
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessPCA
Not implementable for PCA.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Returns the value of the process for the next time step.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
 
nextObservation(double) - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Generates and returns the next observation at time tj+1 = nextTime, using the previous observation time tj defined earlier (either by this method or by setObservationTimes), as well as the value of the previous observation X(tj).
nextObservation(double, double) - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Generates an observation of the process in dt time units, assuming that the process has value x at the current time.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcessEuler
Generates and returns the next observation at time tj+1 = nextTime.
nextObservation(double) - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcessEuler
 
nextObservation(double, double) - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcessEuler
Generates and returns an observation of the process in dt time units, assuming that the process has value x at the current time.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Generates and returns the next observation X(tj) of the stochastic process.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Generates the observation for the next time.
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
 
nextObservation() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiffPCA
This method is not implemented is this class since the path cannot be generated sequentially.
nextPareto(double, double) - Method in class flanagan.math.PsRandom
 
nextPascal(int, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the Pascal Distribution.
nextPermutation(int, int) - Method in interface org.apache.commons.math.random.RandomData
Generates an integer array of length k whose entries are selected randomly, without repetition, from the integers 0 through n-1 (inclusive).
nextPermutation(int, int) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates an integer array of length k whose entries are selected randomly, without repetition, from the integers 0 through n-1 (inclusive).
nextPoint(double[], int) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
nextPoint(double[], int) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2.CycleBasedPointSetBase2Iterator
 
nextPoint(double[], int) - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Returns the first d coordinates of the current point in p, advances to the next point, and returns the index of the new current point.
nextPoint(RandomStream, double[], double[]) - Static method in class umontreal.iro.lecuyer.randvarmulti.DirichletGen
Generates a new point from the Dirichlet distribution with parameters alphas, using the stream stream.
nextPoint(double[]) - Method in class umontreal.iro.lecuyer.randvarmulti.DirichletGen
Generates a point from the Dirichlet distribution.
nextPoint(double[]) - Method in class umontreal.iro.lecuyer.randvarmulti.IIDMultivariateGen
Generates a vector of i.i.d.
nextPoint(NormalGen, double[], double[][], double[]) - Static method in class umontreal.iro.lecuyer.randvarmulti.MultinormalCholeskyGen
Equivalent to nextPoint(gen1, mu, new DenseDoubleMatrix2D(sigma), p).
nextPoint(NormalGen, double[], DoubleMatrix2D, double[]) - Static method in class umontreal.iro.lecuyer.randvarmulti.MultinormalCholeskyGen
Generates a d-dimensional vector from the multinormal distribution with mean vector mu and covariance matrix sigma, using the one-dimensional normal generator gen1 to generate the coordinates of Z, and using the Cholesky decomposition of Σ.
nextPoint(double[]) - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalCholeskyGen
Generates a point from this multinormal distribution.
nextPoint(double[]) - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalGen
Generates a point from this multinormal distribution.
nextPoint(NormalGen, double[], DoubleMatrix2D, double[]) - Static method in class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Generates a d-dimensional vector from the multinormal distribution with mean vector mu and covariance matrix sigma, using the one-dimensional normal generator gen1 to generate the coordinates of Z, and using the PCA decomposition of Σ.
nextPoint(NormalGen, double[], double[][], double[]) - Static method in class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Equivalent to nextPoint(gen1, mu, new DenseDoubleMatrix2D(sigma), p).
nextPoint(double[]) - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Generates a point from this multinormal distribution.
nextPoint(double[]) - Method in class umontreal.iro.lecuyer.randvarmulti.RandomMultivariateGen
Generates a random point p using the the stream contained in this object.
nextPoisson(double) - Method in interface org.apache.commons.math.random.RandomData
Generates a random value from the Poisson distribution with the given mean.
nextPoisson(double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the Poisson distribution with the given mean.
nextPoissonian(double) - Method in class flanagan.math.PsRandom
 
nextPowerOfTwo(int) - Static method in class flanagan.math.FourierTransform
 
nextPowLaw(double, double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a power-law distributed random number with the given exponent and lower cutoff.
nextPowLaw(double, double, DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a power-law distributed random number with the given exponent and lower cutoff.
nextPrime(int) - Static method in class cern.colt.map.PrimeFinder
Returns a prime number which is >= desiredCapacity and very close to desiredCapacity (within 11% if desiredCapacity >= 1000).
nextRadicalInverse(double, double) - Static method in class umontreal.iro.lecuyer.hups.RadicalInverse
A fast method that incrementally computes the radical inverse xi+1 in base b from xi = x = ψb(i), using addition with rigthward carry.
nextRadicalInverse() - Method in class umontreal.iro.lecuyer.hups.RadicalInverse
A fast method that incrementally computes the radical inverse xi+1 in base b from xi = ψb(i), using addition with rigthward carry as described in Wang and Hickernell.
nextRadicalInverseDigits(int, int, int[]) - Static method in class umontreal.iro.lecuyer.hups.RadicalInverse
Given the k digits of the integer radical inverse of i in bdigits, in base b, this method replaces them by the digits of the integer radical inverse of i + 1 and returns their number.
nextRandomNumber() - Method in class jhplot.math.num.random.LinearCongruentialRNG
Access the next random number from this generator.
nextRandomNumber() - Method in class jhplot.math.num.random.MathRNG
Access the next random number from this generator.
nextRandomNumber() - Method in class jhplot.math.num.random.RandomRNG
Access the next random number from this generator.
nextRandomNumber() - Method in interface jhplot.math.num.random.RNG
Access the next random number from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.BernoulliRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.BernoulliRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.BetaRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.BetaRandomVariable
Access the next random variable from this generator.
nextRandomVariable(int, double, RNG) - Static method in class jhplot.math.num.random.BinomialRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.BinomialRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.CauchyRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.CauchyRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.ChiSquaredRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.ChiSquaredRandomVariable
Access the next random variable from this generator.
nextRandomVariable() - Method in interface jhplot.math.num.random.ContinuousRandomVariable
Access the next random variable from this generator.
nextRandomVariable() - Method in interface jhplot.math.num.random.DiscreteRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.ExponentialRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.ExponentialRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.FRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.FRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.GammaRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.GammaRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.GeometricRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.GeometricRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.LaplaceRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.LaplaceRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.LogisticRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.LogisticRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.LogNormalRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.LogNormalRandomVariable
Access the next random variable from this generator.
nextRandomVariable(int, double, RNG) - Static method in class jhplot.math.num.random.NegativeBinomialRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.NegativeBinomialRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.NormalRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.NormalRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.PoissonRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.PoissonRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.RayleighRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.RayleighRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, RNG) - Static method in class jhplot.math.num.random.TRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.TRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, RNG) - Static method in class jhplot.math.num.random.UniformRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.UniformRandomVariable
Access the next random variable from this generator.
nextRandomVariable(double, double, double, RNG) - Static method in class jhplot.math.num.random.WeibullRandomVariable
Access the next random variable using the given generator.
nextRandomVariable() - Method in class jhplot.math.num.random.WeibullRandomVariable
Access the next random variable from this generator.
nextRayleigh(double) - Method in class flanagan.math.PsRandom
 
nextSample(Collection<?>, int) - Method in interface org.apache.commons.math.random.RandomData
Returns an array of k objects selected randomly from the Collection c.
nextSample(Collection<?>, int) - Method in class org.apache.commons.math.random.RandomDataImpl
Uses a 2-cycle permutation shuffle to generate a random permutation.
nextSecureHexString(int) - Method in interface org.apache.commons.math.random.RandomData
Generates a random string of hex characters from a secure random sequence.
nextSecureHexString(int) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random string of hex characters from a secure random sequence.
nextSecureInt(int, int) - Method in interface org.apache.commons.math.random.RandomData
Generates a uniformly distributed random integer between lower and upper (endpoints included) from a secure random sequence.
nextSecureInt(int, int) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random int value uniformly distributed between lower and upper, inclusive.
nextSecureLong(long, long) - Method in interface org.apache.commons.math.random.RandomData
Generates a random long integer between lower and upper (endpoints included).
nextSecureLong(long, long) - Method in class org.apache.commons.math.random.RandomDataImpl
Generate a random long value uniformly distributed between lower and upper, inclusive.
nextSeed() - Method in class cern.jet.random.engine.RandomSeedGenerator
Returns the next seed.
nextSeed() - Method in class cern.jet.random.tdouble.engine.RandomSeedGenerator
Returns the next seed.
nextStudentT(int) - Method in class flanagan.math.PsRandom
 
nextT(double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the T Distribution.
nextTriangular(RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a random number from the standard Triangular distribution in (-1,1).
nextTriangular(DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a random number from the standard Triangular distribution in (-1,1).
nextUniform(double, double) - Method in interface org.apache.commons.math.random.RandomData
Generates a uniformly distributed random value from the open interval (lower,upper) (i.e., endpoints excluded).
nextUniform(double, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a uniformly distributed random value from the open interval (lower,upper) (i.e., endpoints excluded).
nextUp(double) - Static method in class org.apache.commons.math.util.FastMath
Compute next number towards positive infinity.
nextUp(float) - Static method in class org.apache.commons.math.util.FastMath
Compute next number towards positive infinity.
nextVector() - Method in class org.apache.commons.math.random.CorrelatedRandomVectorGenerator
Generate a correlated random vector.
nextVector() - Method in interface org.apache.commons.math.random.RandomVectorGenerator
Generate a random vector.
nextVector() - Method in class org.apache.commons.math.random.UncorrelatedRandomVectorGenerator
Generate an uncorrelated random vector.
nextVector() - Method in class org.apache.commons.math.random.UnitSphereRandomVectorGenerator
Generate a random vector.
nextWeibull(double, double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a weibull distributed random number.
nextWeibull(double, double, DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a weibull distributed random number.
nextWeibull(double, double, double) - Method in class flanagan.math.PsRandom
 
nextWeibull(double, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the Weibull Distribution.
nextZipf(int, double) - Method in class org.apache.commons.math.random.RandomDataImpl
Generates a random value from the Zipf Distribution.
nextZipfInt(double, RandomEngine) - Static method in class cern.jet.random.Distributions
Returns a zipfian distributed random number with the given skew.
nextZipfInt(double, DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.Distributions
Returns a zipfian distributed random number with the given skew.
nFunctions() - Method in class hep.aida.ref.function.SumOfFunctions
 
NiedSequenceBase2 - Class in umontreal.iro.lecuyer.hups
This class implements digital sequences constructed from the Niederreiter sequence in base 2.
NiedSequenceBase2(int, int, int) - Constructor for class umontreal.iro.lecuyer.hups.NiedSequenceBase2
Constructs a new digital sequence in base 2 from the first n = 2k points of the Niederreiter sequence, with w output digits, in dim dimensions.
NiedXingSequenceBase2 - Class in umontreal.iro.lecuyer.hups
This class implements digital sequences based on the Niederreiter-Xing sequence in base 2.
NiedXingSequenceBase2(int, int, int) - Constructor for class umontreal.iro.lecuyer.hups.NiedXingSequenceBase2
Constructs a new Niederreiter-Xing digital sequence in base 2 with n = 2k points and w output digits, in dim dimensions.
nMeanCrossover() - Method in class flanagan.analysis.PCA
 
nMissingErrors() - Method in class flanagan.analysis.RankAnalysis
 
nmToEv(double) - Static method in class flanagan.math.Conv
 
nmToEv(double) - Static method in class flanagan.math.Fmath
 
NO_ESCAPE_CHARACTER - Static variable in class jhplot.io.csv.CSVWriter
The escape constant to use when you wish to suppress all escaping.
NO_INTERPOLATION - Static variable in class cern.jet.random.Empirical
 
NO_INTERPOLATION - Static variable in class cern.jet.random.tdouble.Empirical
 
NO_QUOTE_CHARACTER - Static variable in class jhplot.io.csv.CSVWriter
The quote constant to use when you wish to suppress all quoting.
NoDataException - Exception in org.apache.commons.math.exception
Exception to be thrown when the required data is missing.
NoDataException() - Constructor for exception org.apache.commons.math.exception.NoDataException
Construct the exception.
NoDataException(Localizable) - Constructor for exception org.apache.commons.math.exception.NoDataException
Construct the exception with a specific context.
NODE_ADDED - Static variable in class hep.aida.ref.event.TreeEvent
 
NODE_AVAILABLE - Static variable in class hep.aida.ref.event.TreeEvent
 
NODE_DELETED - Static variable in class hep.aida.ref.event.TreeEvent
 
NODE_MOVED - Static variable in class hep.aida.ref.event.TreeEvent
 
NODE_RENAMED - Static variable in class hep.aida.ref.event.TreeEvent
 
NODE_UNAVAILABLE - Static variable in class hep.aida.ref.event.TreeEvent
 
NoDoubleIterationReporter - Class in cern.colt.matrix.tdouble.algo.solver
An iteration reporter which does nothing.
NoDoubleIterationReporter() - Constructor for class cern.colt.matrix.tdouble.algo.solver.NoDoubleIterationReporter
 
NoFeasibleSolutionException - Exception in org.apache.commons.math.optimization.linear
This class represents exceptions thrown by optimizers when no solution fulfills the constraints.
NoFeasibleSolutionException() - Constructor for exception org.apache.commons.math.optimization.linear.NoFeasibleSolutionException
Simple constructor using a default message.
NoFloatIterationReporter - Class in cern.colt.matrix.tfloat.algo.solver
An iteration reporter which does nothing.
NoFloatIterationReporter() - Constructor for class cern.colt.matrix.tfloat.algo.solver.NoFloatIterationReporter
 
NonLinearConjugateGradientOptimizer - Class in org.apache.commons.math.optimization.general
Non-linear conjugate gradient optimizer.
NonLinearConjugateGradientOptimizer(ConjugateGradientFormula) - Constructor for class org.apache.commons.math.optimization.general.NonLinearConjugateGradientOptimizer
Simple constructor with default settings.
NonMonotonousSequenceException - Exception in org.apache.commons.math.exception
Exception to be thrown when the a sequence of values is not monotonously increasing or decreasing.
NonMonotonousSequenceException(Number, Number, int) - Constructor for exception org.apache.commons.math.exception.NonMonotonousSequenceException
Construct the exception.
NonMonotonousSequenceException(Number, Number, int, MathUtils.OrderDirection, boolean) - Constructor for exception org.apache.commons.math.exception.NonMonotonousSequenceException
Construct the exception.
NonParametricFunction - Class in hep.aida.ref.function
 
NonParametricFunction(String, IFitData) - Constructor for class hep.aida.ref.function.NonParametricFunction
 
NonParametricUnbinnedFit - Class in hep.aida.ref.function.examples
 
NonParametricUnbinnedFit() - Constructor for class hep.aida.ref.function.examples.NonParametricUnbinnedFit
 
NonSquareMatrixException - Exception in org.apache.commons.math.linear
Thrown when an operation defined only for square matrices is applied to non-square ones.
NonSquareMatrixException(int, int) - Constructor for exception org.apache.commons.math.linear.NonSquareMatrixException
Construct an exception with the given message.
NordsieckStepInterpolator - Class in org.apache.commons.math.ode.sampling
This class implements an interpolator for integrators using Nordsieck representation.
NordsieckStepInterpolator() - Constructor for class org.apache.commons.math.ode.sampling.NordsieckStepInterpolator
Simple constructor.
NordsieckStepInterpolator(NordsieckStepInterpolator) - Constructor for class org.apache.commons.math.ode.sampling.NordsieckStepInterpolator
Copy constructor.
Norm - Enum in cern.colt.matrix
Types of matrix norms.
norm(DoubleMatrix2D, Norm) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
 
norm(DoubleMatrix1D, Norm) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
 
norm(FloatMatrix2D, Norm) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
 
norm(FloatMatrix1D, Norm) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
 
norm(double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the L2 norm of an array (Euclidean norm or "length").
norm(int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the L2 norm of an array (Euclidean norm or "length").
norm1(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the one-norm of vector x, which is Sum(abs(x[i])).
norm1(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the one-norm of matrix A, which is the maximum absolute column sum.
norm1(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the one-norm of vector x, which is Sum(abs(x[i])).
norm1(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the one-norm of matrix A, which is the maximum absolute column sum.
norm1(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Returns the 1-norm of matrix A, which is the maximum absolute column sum.
norm1(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the one-norm of vector x, which is Sum(abs(x[i])).
norm1(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the one-norm of matrix A, which is the maximum absolute column sum.
norm1(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Returns the 1-norm of matrix A, which is the maximum absolute column sum.
norm1(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
norm2(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the two-norm (aka euclidean norm) of vector x; equivalent to mult(x,x).
norm2(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the two-norm of matrix A, which is the maximum singular value; obtained from SVD.
norm2() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the two norm, which is max(S).
norm2() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleSingularValueDecomposition
Returns the two norm, which is max(S).
norm2(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the two-norm (aka euclidean norm) of vector x; equivalent to Sqrt(mult(x,x)).
norm2(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the two-norm of matrix A, which is the maximum singular value; obtained from SVD.
norm2() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatSingularValueDecomposition
Returns the two norm, which is max(S).
norm2(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the two-norm (aka euclidean norm) of vector x; equivalent to Sqrt(mult(x,x)).
norm2(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the two-norm of matrix A, which is the maximum singular value; obtained from SVD.
norm2(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
norm2() - Method in class jhplot.math.SingularValueDecomposition
Two norm
Normal - Class in cern.jet.random
Normal (aka Gaussian) distribution; See the math definition and animated definition.
Normal(double, double, RandomEngine) - Constructor for class cern.jet.random.Normal
Constructs a normal (gauss) distribution.
Normal - Class in cern.jet.random.tdouble
Normal (aka Gaussian) distribution; See the math definition and animated definition.
Normal(double, double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.Normal
Constructs a normal (gauss) distribution.
normal(double) - Static method in class cern.jet.stat.Probability
Returns the area under the Normal (Gaussian) probability density function, integrated from minus infinity to x (assumes mean is zero, variance is one).
normal(double, double, double) - Static method in class cern.jet.stat.Probability
Returns the area under the Normal (Gaussian) probability density function, integrated from minus infinity to x.
normal(double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the area under the Normal (Gaussian) probability density function, integrated from minus infinity to x (assumes mean is zero, variance is one).
normal(double, double, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the area under the Normal (Gaussian) probability density function, integrated from minus infinity to x.
normal() - Method in class flanagan.analysis.Regression
 
normal(double[], boolean[]) - Method in class flanagan.analysis.Regression
 
normal(double, double, double) - Static method in class flanagan.analysis.Stat
 
Normal - Class in jhplot.math.num.pdf
The Normal distribution (1).
Normal() - Constructor for class jhplot.math.num.pdf.Normal
Default constructor.
Normal(double, double) - Constructor for class jhplot.math.num.pdf.Normal
Create a distribution with the given mean and standard deviation.
normal(double, double) - Static method in class jhplot.math.Random
Generate a random number from a Gaussian (Normal) random variable.
NormalACRGen - Class in umontreal.iro.lecuyer.randvar
This class implements normal random variate generators using the acceptance-complement ratio method.
NormalACRGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.NormalACRGen
Creates a normal random variate generator with mean mu and standard deviation sigma, using stream s.
NormalACRGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.NormalACRGen
Creates a standard normal random variate generator with mean 0 and standard deviation 1, using stream s.
NormalACRGen(RandomStream, NormalDist) - Constructor for class umontreal.iro.lecuyer.randvar.NormalACRGen
Creates a random variate generator for the normal distribution dist and stream s.
normalApproximateProbability(int) - Method in interface org.apache.commons.math.distribution.PoissonDistribution
Calculates the Poisson distribution function using a normal approximation.
normalApproximateProbability(int) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Calculates the Poisson distribution function using a normal approximation.
normalArray(double, double, int) - Method in class flanagan.math.PsRandom
 
NormalBoxMullerGen - Class in umontreal.iro.lecuyer.randvar
This class implements normal random variate generators using the Box-Muller method.
NormalBoxMullerGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.NormalBoxMullerGen
Creates a normal random variate generator with mean mu and standard deviation sigma, using stream s.
NormalBoxMullerGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.NormalBoxMullerGen
Creates a standard normal random variate generator with mean 0 and standard deviation 1, using stream s.
NormalBoxMullerGen(RandomStream, NormalDist) - Constructor for class umontreal.iro.lecuyer.randvar.NormalBoxMullerGen
Creates a random variate generator for the normal distribution dist and stream s.
normalCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
normalCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
normalCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
NormalDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the normal distribution (e.g.,).
NormalDist() - Constructor for class umontreal.iro.lecuyer.probdist.NormalDist
Constructs a NormalDist object with default parameters μ = 0 and σ = 1.
NormalDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.NormalDist
Constructs a NormalDist object with mean μ = mu and standard deviation σ = sigma.
NormalDistQuick - Class in umontreal.iro.lecuyer.probdist
A variant of the class NormalDist (for the normal distribution with mean μ and variance σ2).
NormalDistQuick() - Constructor for class umontreal.iro.lecuyer.probdist.NormalDistQuick
Constructs a NormalDistQuick object with default parameters μ = 0 and σ = 1.
NormalDistQuick(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.NormalDistQuick
Constructs a NormalDistQuick object with mean μ = mu and standard deviation σ = sigma.
NormalDistribution - Interface in org.apache.commons.math.distribution
Normal (Gauss) Distribution.
NormalDistributionImpl - Class in org.apache.commons.math.distribution
Default implementation of NormalDistribution.
NormalDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.NormalDistributionImpl
Create a normal distribution using the given mean and standard deviation.
NormalDistributionImpl(double, double, double) - Constructor for class org.apache.commons.math.distribution.NormalDistributionImpl
Create a normal distribution using the given mean, standard deviation and inverse cumulative distribution accuracy.
NormalDistributionImpl() - Constructor for class org.apache.commons.math.distribution.NormalDistributionImpl
Creates normal distribution with the mean equal to zero and standard deviation equal to one.
NormalGen - Class in umontreal.iro.lecuyer.randvar
This class implements methods for generating random variates from the normal distribution N(μ, σ).
NormalGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.NormalGen
Creates a normal random variate generator with mean mu and standard deviation sigma, using stream s.
NormalGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.NormalGen
Creates a standard normal random variate generator with mean 0 and standard deviation 1, using stream s.
NormalGen(RandomStream, NormalDist) - Constructor for class umontreal.iro.lecuyer.randvar.NormalGen
Creates a random variate generator for the normal distribution dist and stream s.
normalGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
normalGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
normalIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
normalInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
normalInverse(double) - Static method in class cern.jet.stat.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.
normalInverse(double) - Static method in class cern.jet.stat.tdouble.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.
normalInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
normalInverseCDF(double) - Static method in class flanagan.analysis.Stat
 
NormalInverseGaussianDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the normal inverse gaussian distribution with location parameter μ, scale parameter δ > 0, tail heavyness α > 0, and asymmetry parameter β such that 0 <= | β| < α.
NormalInverseGaussianDist(double, double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Constructor for a normal inverse gaussian distribution with parameters α = alpha, β = beta, μ = mu and δ = delta.
NormalInverseGaussianGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the normal inverse gaussian (NIG) distribution.
NormalInverseGaussianGen(RandomStream, double, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.NormalInverseGaussianGen
Creates an normal inverse gaussian random variate generator with parameters α = alpha, β = beta, μ = mu and δ = delta, using stream s.
NormalInverseGaussianGen(RandomStream, NormalInverseGaussianDist) - Constructor for class umontreal.iro.lecuyer.randvar.NormalInverseGaussianGen
Creates a new generator for the distribution dist, using stream s.
NormalInverseGaussianIGGen - Class in umontreal.iro.lecuyer.randvar
.
NormalInverseGaussianIGGen(InverseGaussianGen, NormalGen, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.NormalInverseGaussianIGGen
Creates a random variate generator with parameters α, β = beta, μ = mu and δ, using generators ig and ng, as described above.
NormalInverseGaussianProcess - Class in umontreal.iro.lecuyer.stochprocess
This class represents a normal inverse gaussian process (NIG).
NormalInverseGaussianProcess(double, double, double, double, double, RandomStream, InverseGaussianProcess) - Constructor for class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Given an InverseGaussianProcess igP, constructs a new NormalInverseGaussianProcess.
NormalInverseGaussianProcess(double, double, double, double, double, RandomStream, RandomStream, RandomStream, String) - Constructor for class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Constructs a new NormalInverseGaussianProcess.
NormalInverseGaussianProcess(double, double, double, double, double, RandomStream, String) - Constructor for class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Same as above, but all RandomStream's are set to the same stream, streamAll.
normalizationAmplitude() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
normalizationAmplitude(ArrayList[], ArrayList[]) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.ExponentialCoreNorm
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.ExponentialCoreNotNorm
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.FunctionCore
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.GaussianCore2DNorm
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.GaussianCore2DNotNorm
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.GaussianCoreNorm
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.GaussianCoreNotNorm
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.JELFunctionCore
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.LorentzianCoreNotNorm
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.MoyalCoreNotNorm
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.PolynomialCoreNorm
 
normalizationAmplitude(double[], double[]) - Method in class hep.aida.ref.function.PolynomialCoreNotNorm
 
normalizationParameter() - Method in class hep.aida.ref.fitter.InternalFitFunction
 
normalizationParameter() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
normalizationParameter() - Method in class hep.aida.ref.function.AbstractIFunction
 
normalizationParameter() - Method in class hep.aida.ref.function.BaseModelFunction
 
normalizationParameter() - Method in class hep.aida.ref.function.NonParametricFunction
 
normalizationParameter() - Method in class hep.aida.ref.function.SumOfFunctions
 
normalizationRange(int) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
normalizationRange(int) - Method in class hep.aida.ref.function.AbstractIFunction
 
normalizationRange(int) - Method in class hep.aida.ref.function.BaseModelFunction
 
normalize() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Normalizes this matrix, i.e.
normalize() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Normalizes this matrix, i.e.
normalize() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Normalizes this matrix, i.e.
normalize() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Normalizes this matrix, i.e.
normalize() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Normalizes this matrix, i.e.
normalize() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Normalizes this matrix, i.e.
normalize(boolean) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
normalize(boolean) - Method in class hep.aida.ref.function.AbstractIFunction
 
normalize(boolean) - Method in class hep.aida.ref.function.BaseModelFunction
 
normalize(double[]) - Static method in class jhplot.math.ArrayMathUtils
Renormalizes the array so that its L2 norm is 1 (up to computational errors).
normalize() - Method in class jhplot.v3d.Vector3d
 
normalize() - Method in class org.apache.commons.math.geometry.Vector3D
Get a normalized vector aligned with the instance.
normalize(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Normalize (standardize) the series, so in the end it is having a mean of 0 and a standard deviation of 1.
normalizeAngle(double, double) - Static method in class org.apache.commons.math.util.MathUtils
Normalize an angle in a 2&pi wide interval around a center value.
normalizeArray(double[], double) - Static method in class org.apache.commons.math.util.MathUtils
Normalizes an array to make it sum to a specified value.
NormalizedRandomGenerator - Interface in org.apache.commons.math.random
This interface represent a normalized random generator for scalars.
NormalKindermannRamageGen - Class in umontreal.iro.lecuyer.randvar
This class implements normal random variate generators using the Kindermann-Ramage method.
NormalKindermannRamageGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.NormalKindermannRamageGen
Creates a normal random variate generator with mean mu and standard deviation sigma, using stream s.
NormalKindermannRamageGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.NormalKindermannRamageGen
Creates a standard normal random variate generator with mean 0 and standard deviation 1, using stream s.
NormalKindermannRamageGen(RandomStream, NormalDist) - Constructor for class umontreal.iro.lecuyer.randvar.NormalKindermannRamageGen
Creates a random variate generator for the normal distribution dist and stream s.
normalMu() - Method in class flanagan.analysis.ProbabilityPlot
 
normalMuError() - Method in class flanagan.analysis.ProbabilityPlot
 
normalOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
normalOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
normalOrderStatisticMedians(int) - Static method in class flanagan.analysis.Stat
 
normalPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
normalPlot() - Method in class flanagan.analysis.Regression
 
normalPlot(double[], boolean[]) - Method in class flanagan.analysis.Regression
 
NormalPolarGen - Class in umontreal.iro.lecuyer.randvar
This class implements normal random variate generators using the polar method with rejection.
NormalPolarGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.NormalPolarGen
Creates a normal random variate generator with mean mu and standard deviation sigma, using stream s.
NormalPolarGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.NormalPolarGen
Creates a standard normal random variate generator with μ = 0 and σ = 1, using stream s.
NormalPolarGen(RandomStream, NormalDist) - Constructor for class umontreal.iro.lecuyer.randvar.NormalPolarGen
Creates a random variate generator for the normal distribution dist and stream s.
normalProb(double, double, double) - Static method in class flanagan.analysis.Stat
 
normalProb(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
normalProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
normalRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
normalRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
NormalRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Normal distribution.
NormalRandomVariable() - Constructor for class jhplot.math.num.random.NormalRandomVariable
Default constructor.
NormalRandomVariable(double, double) - Constructor for class jhplot.math.num.random.NormalRandomVariable
Create a random variable with the given mean and standard deviation.
NormalRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.NormalRandomVariable
Create a random variable with the given parameters.
normalSigma() - Method in class flanagan.analysis.ProbabilityPlot
 
normalSigmaError() - Method in class flanagan.analysis.ProbabilityPlot
 
normalStandardCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
normalStandardGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
normalstandardGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
normalStandardInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
normalStandardOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
normalStandardProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
normalStandardSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
normalSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
normalVarimaxRotation(int) - Method in class flanagan.analysis.PCA
 
normalVarimaxRotation(double[][], double[]) - Static method in class flanagan.analysis.PCA
 
normalVarimaxRotation(double[][], double[], double, int) - Static method in class flanagan.analysis.PCA
 
normF(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the Frobenius norm of matrix A, which is Sqrt(Sum(A[i,j]2)).
normF(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the Frobenius norm of matrix A, which is Sqrt(Sum(A[i,j]2)).
normF(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the Frobenius norm of matrix A, which is Sqrt(Sum(A[i]2)).
normF(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the Frobenius norm of matrix A, which is Sqrt(Sum(A[i,j]2)).
normF(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the Frobenius norm of matrix A, which is Sqrt(Sum(A[i]2)).
normF(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
normInf(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
normInfinity(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the infinity norm of vector x, which is Max(abs(x[i])).
normInfinity(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the infinity norm of matrix A, which is the maximum absolute row sum.
normInfinity(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the infinity norm of vector x, which is Max(abs(x[i])).
normInfinity(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the infinity norm of matrix A, which is the maximum absolute row sum.
normInfinity(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Returns the infinity norm of matrix A, which is the maximum absolute row sum.
normInfinity(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the infinity norm of vector x, which is Max(abs(x[i])).
normInfinity(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the infinity norm of matrix A, which is the maximum absolute row sum.
normInfinity(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Returns the infinity norm of matrix A, which is the maximum absolute row sum.
noRoundingErrorCheck() - Static method in class flanagan.interpolation.BiCubicSpline
 
noRoundingErrorCheck() - Static method in class flanagan.interpolation.BiCubicSplineFirstDerivative
 
noRoundingErrorCheck() - Static method in class flanagan.interpolation.BiCubicSplinePartialDerivative
 
noRoundingErrorCheck() - Static method in class flanagan.interpolation.CubicSpline
 
noRoundingErrorCheck() - Static method in class flanagan.interpolation.PolyCubicSpline
 
noRoundingErrorCheck() - Static method in class flanagan.interpolation.QuadriCubicSpline
 
noRoundingErrorCheck() - Static method in class flanagan.interpolation.TriCubicSpline
 
not() - Method in class cern.colt.bitvector.BitMatrix
Performs a logical NOT on the bits of the receiver.
not() - Method in class cern.colt.bitvector.BitVector
Performs a logical NOT on the bits of the receiver (A = ~A).
not() - Method in class cern.colt.matrix.tbit.BitMatrix
Performs a logical NOT on the bits of the receiver.
not() - Method in class cern.colt.matrix.tbit.BitVector
Performs a logical NOT on the bits of the receiver (A = ~A).
not - Static variable in class cern.jet.math.IntFunctions
Function that returns ~a.
not - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns ~a.
not - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns ~a.
not() - Method in class umontreal.iro.lecuyer.util.BitMatrix
Returns the BitMatrix resulting from the application of the not operator on the original BitMatrix.
not() - Method in class umontreal.iro.lecuyer.util.BitVector
Returns a BitVector which is the result of the not operator on the current BitVector.
NotARotationMatrixException - Exception in org.apache.commons.math.geometry
This class represents exceptions thrown while building rotations from matrices.
NotARotationMatrixException(String, Object...) - Constructor for exception org.apache.commons.math.geometry.NotARotationMatrixException
Deprecated. as of 2.2 replaced by NotARotationMatrixException.NotARotationMatrixException(Localizable, Object...)
NotARotationMatrixException(Localizable, Object...) - Constructor for exception org.apache.commons.math.geometry.NotARotationMatrixException
Simple constructor.
notEquals(SpacePoint) - Method in class hephysics.vec.SpacePoint
Inequality
notifyListeners(double[]) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Notifies the observation x to all registered observers if broadcasting is ON.
notifyListeners(double) - Method in class umontreal.iro.lecuyer.stat.StatProbe
Notifies the observation x to all registered observers if broadcasting is ON.
NotPositiveDefiniteMatrixException - Exception in org.apache.commons.math.linear
This class represents exceptions thrown when a matrix expected to be positive definite is not.
NotPositiveDefiniteMatrixException() - Constructor for exception org.apache.commons.math.linear.NotPositiveDefiniteMatrixException
Simple constructor.
NotPositiveException - Exception in org.apache.commons.math.exception
Exception to be thrown when the argument is negative.
NotPositiveException(Number) - Constructor for exception org.apache.commons.math.exception.NotPositiveException
Construct the exception.
NotPositiveException(Localizable, Number) - Constructor for exception org.apache.commons.math.exception.NotPositiveException
Construct the exception with a specific context.
NotStrictlyPositiveException - Exception in org.apache.commons.math.exception
Exception to be thrown when the argument is negative.
NotStrictlyPositiveException(Number) - Constructor for exception org.apache.commons.math.exception.NotStrictlyPositiveException
Construct the exception.
NotStrictlyPositiveException(Localizable, Number) - Constructor for exception org.apache.commons.math.exception.NotStrictlyPositiveException
Construct the exception with a specific context.
NotSymmetricMatrixException - Exception in org.apache.commons.math.linear
This class represents exceptions thrown when a matrix expected to be symmetric is not
NotSymmetricMatrixException() - Constructor for exception org.apache.commons.math.linear.NotSymmetricMatrixException
Simple constructor.
nPercentileCrossover() - Method in class flanagan.analysis.PCA
 
nRoot(ValueErr, int) - Static method in class jhplot.math.ValueErr
Take nth root from the value (n is above 1)
nRows() - Method in class flanagan.analysis.RankAnalysis
 
ns - Static variable in class cern.clhep.Units
 
nsinc(double) - Static method in class flanagan.math.Fmath
 
NTESTTYPES - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Total number of test types
nthRoot(ErrorProp, int) - Static method in class flanagan.analysis.ErrorProp
 
nthRoot(int) - Method in class org.apache.commons.math.complex.Complex
Computes the n-th roots of this complex number.
NullArgumentException - Exception in org.apache.commons.math.exception
All conditions checks that fail due to a null argument must throw this exception.
NullArgumentException() - Constructor for exception org.apache.commons.math.exception.NullArgumentException
Default constructor.
NullArgumentException(Localizable) - Constructor for exception org.apache.commons.math.exception.NullArgumentException
 
Num - Class in umontreal.iro.lecuyer.util
This class provides a few constants and some methods to compute numerical quantities such as factorials, combinations, gamma functions, and so on.
NumberIsTooLargeException - Exception in org.apache.commons.math.exception
Exception to be thrown when a number is too large.
NumberIsTooLargeException(Number, Number, boolean) - Constructor for exception org.apache.commons.math.exception.NumberIsTooLargeException
Construct the exception.
NumberIsTooLargeException(Localizable, Number, Number, boolean) - Constructor for exception org.apache.commons.math.exception.NumberIsTooLargeException
Construct the exception with a specific context.
NumberIsTooSmallException - Exception in org.apache.commons.math.exception
Exception to be thrown when a number is too small.
NumberIsTooSmallException(Number, Number, boolean) - Constructor for exception org.apache.commons.math.exception.NumberIsTooSmallException
Construct the exception.
NumberIsTooSmallException(Localizable, Number, Number, boolean) - Constructor for exception org.apache.commons.math.exception.NumberIsTooSmallException
Construct the exception with a specific context.
numberLabels() - Method in class jhplot.HPlot
No labels on the current plot.
numberObs() - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
Assuming that each tally in this list contains the same number of observations, returns the number of observations in tally 0, or 0 if this list is empty.
numberObs() - Method in class umontreal.iro.lecuyer.stat.Tally
Returns the number of observations given to this probe since its last initialization.
numberOfDataPoints() - Method in class flanagan.analysis.ProbabilityPlot
 
numberOfDecimalPlaces(int) - Method in class flanagan.analysis.Scores
 
numberOfDeletedItems() - Method in class flanagan.analysis.Scores
 
numberOfDeletedPersons() - Method in class flanagan.analysis.Scores
 
numberOfDeletedScores() - Method in class flanagan.analysis.Scores
 
numberOfParameters() - Method in class hep.aida.ref.fitter.InternalFitFunction
 
numberOfParameters() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
numberOfParameters() - Method in class hep.aida.ref.function.AbstractIFunction
 
numberOfParameters() - Method in class hep.aida.ref.function.BaseModelFunction
 
numberOfParameters() - Method in class hep.aida.ref.function.ExponentModelFunction
 
numberOfParameters() - Method in class hep.aida.ref.function.FunctionCore
 
numberOfParameters() - Method in class hep.aida.ref.function.PolynomialModelFunction
 
numberOfParameters() - Method in class hep.aida.ref.function.SumOfFunctions
 
numberOfReplacedScores() - Method in class flanagan.analysis.Scores
 
numberPrimitives() - Method in class jhplot.HPlot
No of primitives for the current plot.
NumberTransformer - Interface in org.apache.commons.math.util
Subclasses implementing this interface can transform Objects to doubles.
numColumns() - Method in class cern.colt.matrix.io.MatrixSize
Returns the number of columns in the matrix
numColumns() - Method in class umontreal.iro.lecuyer.util.BitMatrix
Returns the number of columns of the BitMatrix.
numColumns() - Method in class umontreal.iro.lecuyer.util.DMatrix
Returns the number of columns of the DMatrix.
numEntries() - Method in class cern.colt.matrix.io.MatrixSize
Returns the number of entries stored
numEntries() - Method in class cern.colt.matrix.io.VectorSize
Returns the number of entries in the vector
Numeric - Class in jhplot.math
Do some numerical calculations.
Numeric() - Constructor for class jhplot.math.Numeric
 
NumericException - Exception in jhplot.math.num
Generic numerical exception thrown by numerics4j.
NumericException(String) - Constructor for exception jhplot.math.num.NumericException
Create an execption with the given message.
numericGradient(double[]) - Method in class hep.aida.ref.function.BaseModelFunction
 
numericParameterGradient(double[]) - Method in class hep.aida.ref.function.BaseModelFunction
 
NUMINTERVALS - Static variable in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Default number of intervals for Simpson's integral.
NUMINTERVALS - Static variable in class umontreal.iro.lecuyer.probdist.TruncatedDist
 
numRows() - Method in class cern.colt.matrix.io.MatrixSize
Returns the number of rows in the matrix
numRows() - Method in class umontreal.iro.lecuyer.util.BitMatrix
Returns the number of rows of the BitMatrix.
numRows() - Method in class umontreal.iro.lecuyer.util.DMatrix
Returns the number of rows of the DMatrix.

O

obj - Variable in class jhplot.v3d.Model3d
 
Object3d - Class in jhplot.v3d
 
Object3d(Model3d, int, int) - Constructor for class jhplot.v3d.Object3d
 
Object3d(String, Model3d, int, int) - Constructor for class jhplot.v3d.Object3d
 
ObjectArrayList - Class in cern.colt.list
Resizable list holding Object elements; implemented with arrays.
ObjectArrayList() - Constructor for class cern.colt.list.ObjectArrayList
Constructs an empty list.
ObjectArrayList(Object[]) - Constructor for class cern.colt.list.ObjectArrayList
Constructs a list containing the specified elements.
ObjectArrayList(int) - Constructor for class cern.colt.list.ObjectArrayList
Constructs an empty list with the specified initial capacity.
ObjectArrayList - Class in cern.colt.list.tobject
Resizable list holding Object elements; implemented with arrays.
ObjectArrayList() - Constructor for class cern.colt.list.tobject.ObjectArrayList
Constructs an empty list.
ObjectArrayList(Object[]) - Constructor for class cern.colt.list.tobject.ObjectArrayList
Constructs a list containing the specified elements.
ObjectArrayList(int) - Constructor for class cern.colt.list.tobject.ObjectArrayList
Constructs an empty list with the specified initial capacity.
ObjectBuffer - Class in cern.colt.buffer
Fixed sized (non resizable) streaming buffer connected to a target ObjectBufferConsumer to which data is automatically flushed upon buffer overflow.
ObjectBuffer(ObjectBufferConsumer, int) - Constructor for class cern.colt.buffer.ObjectBuffer
Constructs and returns a new buffer with the given target.
ObjectBuffer - Class in cern.colt.buffer.tobject
Fixed sized (non resizable) streaming buffer connected to a target ObjectBufferConsumer to which data is automatically flushed upon buffer overflow.
ObjectBuffer(ObjectBufferConsumer, int) - Constructor for class cern.colt.buffer.tobject.ObjectBuffer
Constructs and returns a new buffer with the given target.
ObjectBufferConsumer - Interface in cern.colt.buffer
Target of a streaming ObjectBuffer into which data is flushed upon buffer overflow.
ObjectBufferConsumer - Interface in cern.colt.buffer.tobject
Target of a streaming ObjectBuffer into which data is flushed upon buffer overflow.
ObjectFactory1D - Class in cern.colt.matrix
Factory for convenient construction of 1-d matrices holding Object cells.
ObjectFactory1D - Class in cern.colt.matrix.tobject
Factory for convenient construction of 1-d matrices holding Object cells.
ObjectFactory2D - Class in cern.colt.matrix
Factory for convenient construction of 2-d matrices holding Object cells.
ObjectFactory2D - Class in cern.colt.matrix.tobject
Factory for convenient construction of 2-d matrices holding Object cells.
ObjectFactory3D - Class in cern.colt.matrix
Factory for convenient construction of 3-d matrices holding Object cells.
ObjectFactory3D - Class in cern.colt.matrix.tobject
Factory for convenient construction of 3-d matrices holding Object cells.
ObjectFormatter - Class in cern.colt.matrix.tobject.algo
Flexible, well human readable matrix print formatting.
ObjectFormatter() - Constructor for class cern.colt.matrix.tobject.algo.ObjectFormatter
Constructs and returns a matrix formatter with alignment LEFT.
ObjectFormatter(String) - Constructor for class cern.colt.matrix.tobject.algo.ObjectFormatter
Constructs and returns a matrix formatter.
ObjectFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes a single argument and returns a single value.
ObjectFunction - Interface in cern.colt.function.tobject
Interface that represents a function object: a function that takes a single argument and returns a single value.
ObjectListAdapter - Class in cern.colt.list.adapter
Adapter that permits an ObjectArrayList to be viewed and treated as a JDK 1.2 AbstractList.
ObjectListAdapter(ObjectArrayList) - Constructor for class cern.colt.list.adapter.ObjectListAdapter
Constructs a list backed by the specified content list.
ObjectListAdapter - Class in cern.colt.list.tobject
Adapter that permits an ObjectArrayList to be viewed and treated as a JDK 1.2 AbstractList.
ObjectListAdapter(ObjectArrayList) - Constructor for class cern.colt.list.tobject.ObjectListAdapter
Constructs a list backed by the specified content list.
ObjectMatrix1D - Class in cern.colt.matrix
Abstract base class for 1-d matrices (aka vectors) holding Object elements.
ObjectMatrix1D - Class in cern.colt.matrix.tobject
Abstract base class for 1-d matrices (aka vectors) holding Object elements.
ObjectMatrix1DComparator - Interface in cern.colt.matrix.objectalgo
A comparison function which imposes a total ordering on some collection of elements.
ObjectMatrix1DComparator - Interface in cern.colt.matrix.tobject.algo
A comparison function which imposes a total ordering on some collection of elements.
ObjectMatrix1DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
ObjectMatrix1DProcedure - Interface in cern.colt.matrix.tobject
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
ObjectMatrix2D - Class in cern.colt.matrix
Abstract base class for 2-d matrices holding Object elements.
ObjectMatrix2D - Class in cern.colt.matrix.tobject
Abstract base class for 2-d matrices holding Object elements.
ObjectMatrix2DComparator - Interface in cern.colt.matrix.objectalgo
A comparison function which imposes a total ordering on some collection of elements.
ObjectMatrix2DComparator - Interface in cern.colt.matrix.tobject.algo
A comparison function which imposes a total ordering on some collection of elements.
ObjectMatrix2DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
ObjectMatrix2DProcedure - Interface in cern.colt.matrix.tobject
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
ObjectMatrix3D - Class in cern.colt.matrix
Abstract base class for 3-d matrices holding Object elements.
ObjectMatrix3D - Class in cern.colt.matrix.tobject
Abstract base class for 3-d matrices holding Object elements.
ObjectMatrix3DProcedure - Interface in cern.colt.matrix
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
ObjectMatrix3DProcedure - Interface in cern.colt.matrix.tobject
Interface that represents a condition or procedure object: takes a single argument and returns a boolean value.
ObjectObjectFunction - Interface in cern.colt.function
Interface that represents a function object: a function that takes two arguments and returns a single value.
ObjectObjectFunction - Interface in cern.colt.function.tobject
Interface that represents a function object: a function that takes two arguments and returns a single value.
ObjectPartitioning - Class in cern.colt.matrix.tobject.algo
Given some interval boundaries, partitions matrices such that cell values falling into an interval are placed next to each other.
ObjectProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
ObjectProcedure - Interface in cern.colt.function.tobject
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
ObjectSorting - Class in cern.colt.matrix.tobject.algo
Matrix quicksorts and mergesorts.
ObservationListener - Interface in umontreal.iro.lecuyer.stat
Represents an object that can listen to observations broadcast by statistical probes.
ObserverAdapter - Class in hep.aida.ref.event
An ObserverAdapter can be used as a base class for class that wants to act as both AIDAListener and Observable, and relay things it observers to its Observers.
ObserverAdapter() - Constructor for class hep.aida.ref.event.ObserverAdapter
 
ObserverAdapter(Object) - Constructor for class hep.aida.ref.event.ObserverAdapter
 
ODEIntegrator - Interface in org.apache.commons.math.ode
This interface defines the common parts shared by integrators for first and second order differential equations.
ODEWithJacobians - Interface in org.apache.commons.math.ode.jacobians
Deprecated. as of 2.2 the complete package is deprecated, it will be replaced in 3.0 by a completely rewritten implementation
of(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.ComposableFunction
Precompose the instance with another function.
offset() - Method in class cern.hep.aida.bin.AbstractBin
Returns offset(0).
offset(int) - Method in class cern.hep.aida.bin.AbstractBin
Returns the relative or absolute position for the center of the bin; override this method if necessary.
offset() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns offset(0).
offset(int) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns the relative or absolute position for the center of the bin; override this method if necessary.
offset() - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns offset(0).
offset(int) - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns the relative or absolute position for the center of the bin; override this method if necessary.
ohm - Static variable in class cern.clhep.Units
 
OLSMultipleLinearRegression - Class in org.apache.commons.math.stat.regression
Implements ordinary least squares (OLS) to estimate the parameters of a multiple linear regression model.
OLSMultipleLinearRegression() - Constructor for class org.apache.commons.math.stat.regression.OLSMultipleLinearRegression
 
omaxScale - Variable in class jhplot.v3d.Canvas3d
 
ominScale - Variable in class jhplot.v3d.Canvas3d
 
one(int, int) - Static method in class jhplot.math.DoubleArray
Deprecated. use fill(int m, int n, 1.0) instead.
one(int, int, double) - Static method in class jhplot.math.DoubleArray
Deprecated. use fill(int m, int n, double c) instead.
one(int) - Static method in class jhplot.math.DoubleArray
Deprecated. use fill(int m, double c) instead.
one(int, double) - Static method in class jhplot.math.DoubleArray
Deprecated. Use fill(int m, double c) instead.
ONE - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The constant function always returning 1.
ONE - Static variable in class org.apache.commons.math.complex.Complex
A complex number representing "1.0 + 0.0i"
ONE - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "1".
ONE - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "1".
ONE - Static variable in class org.apache.commons.math.util.BigReal
A big real representing 1.
ONE_FIFTH - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "1/5".
ONE_FIFTH - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "1/5".
ONE_HALF - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "1/2".
ONE_HALF - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "1/2".
ONE_QUARTER - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "1/4".
ONE_QUARTER - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "1/4".
ONE_THIRD - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "1/3".
ONE_THIRD - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "1/3".
oneDarray(int) - Static method in class flanagan.analysis.ErrorProp
 
oneDarray(int, double, double) - Static method in class flanagan.analysis.ErrorProp
 
oneDarray(int, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
oneDarray(int, int, int) - Static method in class flanagan.interpolation.BiCubicSpline
 
oneDarray(int, int) - Static method in class flanagan.interpolation.CubicSpline
 
oneDarray(int, int) - Static method in class flanagan.interpolation.CubicSplineFast
 
oneDarray(int, int) - Static method in class flanagan.interpolation.CubicSplineShort
 
oneDarray(int, int, int, int) - Static method in class flanagan.interpolation.TriCubicSpline
 
oneDarray(int, ValueErr) - Static method in class jhplot.math.ValueErr
Create a one dimensional array of ValueErr objects of length n and m
oneMinusExponential() - Method in class flanagan.analysis.Regression
 
oneMinusExponentialPlot() - Method in class flanagan.analysis.Regression
 
oneNorm() - Method in class flanagan.math.Matrix
 
oneOverSqrt() - Method in class flanagan.analysis.Stat
 
oneOverSqrt() - Method in class flanagan.math.ArrayMaths
 
OnePointCrossover<T> - Class in org.apache.commons.math.genetics
One point crossover policy.
OnePointCrossover() - Constructor for class org.apache.commons.math.genetics.OnePointCrossover
 
OneWayAnova - Interface in org.apache.commons.math.stat.inference
An interface for one-way ANOVA (analysis of variance).
oneWayAnovaFValue(Collection<double[]>) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
OneWayAnovaImpl - Class in org.apache.commons.math.stat.inference
Implements one-way ANOVA statistics defined in the OneWayAnovaImpl interface.
OneWayAnovaImpl() - Constructor for class org.apache.commons.math.stat.inference.OneWayAnovaImpl
Default constructor.
oneWayAnovaPValue(Collection<double[]>) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
oneWayAnovaTest(Collection<double[]>, double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
oof - Variable in class jhplot.io.HFile
 
oof - Variable in class jhplot.io.HFileXML
 
oos - Variable in class jhplot.io.HFile
 
oos - Variable in class jhplot.io.HFileXML
 
OpenDoubleIntHashMap - Class in cern.colt.map
Hash map holding (key,value) associations of type (double-->int); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenDoubleIntHashMap() - Constructor for class cern.colt.map.OpenDoubleIntHashMap
Constructs an empty map with default capacity and default load factors.
OpenDoubleIntHashMap(int) - Constructor for class cern.colt.map.OpenDoubleIntHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenDoubleIntHashMap(int, double, double) - Constructor for class cern.colt.map.OpenDoubleIntHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenDoubleIntHashMap - Class in cern.colt.map.tdouble
Hash map holding (key,value) associations of type (double-->int); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenDoubleIntHashMap() - Constructor for class cern.colt.map.tdouble.OpenDoubleIntHashMap
Constructs an empty map with default capacity and default load factors.
OpenDoubleIntHashMap(int) - Constructor for class cern.colt.map.tdouble.OpenDoubleIntHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenDoubleIntHashMap(int, double, double) - Constructor for class cern.colt.map.tdouble.OpenDoubleIntHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenDoubleLongHashMap - Class in cern.colt.map.tdouble
Hash map holding (key,value) associations of type (double-->long); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenDoubleLongHashMap() - Constructor for class cern.colt.map.tdouble.OpenDoubleLongHashMap
Constructs an empty map with default capacity and default load factors.
OpenDoubleLongHashMap(int) - Constructor for class cern.colt.map.tdouble.OpenDoubleLongHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenDoubleLongHashMap(int, double, double) - Constructor for class cern.colt.map.tdouble.OpenDoubleLongHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenFloatIntHashMap - Class in cern.colt.map.tfloat
Hash map holding (key,value) associations of type (float-->int); Automatically grows and shrinks as needed; Implemented using open addressing with float hashing.
OpenFloatIntHashMap() - Constructor for class cern.colt.map.tfloat.OpenFloatIntHashMap
Constructs an empty map with default capacity and default load factors.
OpenFloatIntHashMap(int) - Constructor for class cern.colt.map.tfloat.OpenFloatIntHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenFloatIntHashMap(int, double, double) - Constructor for class cern.colt.map.tfloat.OpenFloatIntHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenFloatLongHashMap - Class in cern.colt.map.tfloat
Hash map holding (key,value) associations of type (float-->long); Automatically grows and shrinks as needed; Implemented using open addressing with float hashing.
OpenFloatLongHashMap() - Constructor for class cern.colt.map.tfloat.OpenFloatLongHashMap
Constructs an empty map with default capacity and default load factors.
OpenFloatLongHashMap(int) - Constructor for class cern.colt.map.tfloat.OpenFloatLongHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenFloatLongHashMap(int, double, double) - Constructor for class cern.colt.map.tfloat.OpenFloatLongHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntDoubleHashMap - Class in cern.colt.map
Hash map holding (key,value) associations of type (int-->double); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenIntDoubleHashMap() - Constructor for class cern.colt.map.OpenIntDoubleHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntDoubleHashMap(int) - Constructor for class cern.colt.map.OpenIntDoubleHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntDoubleHashMap(int, double, double) - Constructor for class cern.colt.map.OpenIntDoubleHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntDoubleHashMap - Class in cern.colt.map.tdouble
Hash map holding (key,value) associations of type (int-->double); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenIntDoubleHashMap() - Constructor for class cern.colt.map.tdouble.OpenIntDoubleHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntDoubleHashMap(int) - Constructor for class cern.colt.map.tdouble.OpenIntDoubleHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntDoubleHashMap(int, double, double) - Constructor for class cern.colt.map.tdouble.OpenIntDoubleHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntFloatHashMap - Class in cern.colt.map.tfloat
Hash map holding (key,value) associations of type (int-->float); Automatically grows and shrinks as needed; Implemented using open addressing with float hashing.
OpenIntFloatHashMap() - Constructor for class cern.colt.map.tfloat.OpenIntFloatHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntFloatHashMap(int) - Constructor for class cern.colt.map.tfloat.OpenIntFloatHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntFloatHashMap(int, double, double) - Constructor for class cern.colt.map.tfloat.OpenIntFloatHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntIntHashMap - Class in cern.colt.map
Hash map holding (key,value) associations of type (int-->int); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenIntIntHashMap() - Constructor for class cern.colt.map.OpenIntIntHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntIntHashMap(int) - Constructor for class cern.colt.map.OpenIntIntHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntIntHashMap(int, double, double) - Constructor for class cern.colt.map.OpenIntIntHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntIntHashMap - Class in cern.colt.map.tint
Hash map holding (key,value) associations of type (int-->int); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenIntIntHashMap() - Constructor for class cern.colt.map.tint.OpenIntIntHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntIntHashMap(int) - Constructor for class cern.colt.map.tint.OpenIntIntHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntIntHashMap(int, double, double) - Constructor for class cern.colt.map.tint.OpenIntIntHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntLongHashMap - Class in cern.colt.map.tlong
Hash map holding (key,value) associations of type (int-->long); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenIntLongHashMap() - Constructor for class cern.colt.map.tlong.OpenIntLongHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntLongHashMap(int) - Constructor for class cern.colt.map.tlong.OpenIntLongHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntLongHashMap(int, double, double) - Constructor for class cern.colt.map.tlong.OpenIntLongHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntObjectHashMap - Class in cern.colt.map
Hash map holding (key,value) associations of type (int-->Object); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenIntObjectHashMap() - Constructor for class cern.colt.map.OpenIntObjectHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntObjectHashMap(int) - Constructor for class cern.colt.map.OpenIntObjectHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntObjectHashMap(int, double, double) - Constructor for class cern.colt.map.OpenIntObjectHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntObjectHashMap - Class in cern.colt.map.tobject
Hash map holding (key,value) associations of type (int-->Object); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenIntObjectHashMap() - Constructor for class cern.colt.map.tobject.OpenIntObjectHashMap
Constructs an empty map with default capacity and default load factors.
OpenIntObjectHashMap(int) - Constructor for class cern.colt.map.tobject.OpenIntObjectHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenIntObjectHashMap(int, double, double) - Constructor for class cern.colt.map.tobject.OpenIntObjectHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenIntToDoubleHashMap - Class in org.apache.commons.math.util
Open addressed map from int to double.
OpenIntToDoubleHashMap() - Constructor for class org.apache.commons.math.util.OpenIntToDoubleHashMap
Build an empty map with default size and using NaN for missing entries.
OpenIntToDoubleHashMap(double) - Constructor for class org.apache.commons.math.util.OpenIntToDoubleHashMap
Build an empty map with default size
OpenIntToDoubleHashMap(int) - Constructor for class org.apache.commons.math.util.OpenIntToDoubleHashMap
Build an empty map with specified size and using NaN for missing entries.
OpenIntToDoubleHashMap(int, double) - Constructor for class org.apache.commons.math.util.OpenIntToDoubleHashMap
Build an empty map with specified size.
OpenIntToDoubleHashMap(OpenIntToDoubleHashMap) - Constructor for class org.apache.commons.math.util.OpenIntToDoubleHashMap
Copy constructor.
OpenIntToDoubleHashMap.Iterator - Class in org.apache.commons.math.util
Iterator class for the map.
OpenIntToFieldHashMap<T extends FieldElement<T>> - Class in org.apache.commons.math.util
Open addressed map from int to FieldElement.
OpenIntToFieldHashMap(Field<T>) - Constructor for class org.apache.commons.math.util.OpenIntToFieldHashMap
Build an empty map with default size and using zero for missing entries.
OpenIntToFieldHashMap(Field<T>, T) - Constructor for class org.apache.commons.math.util.OpenIntToFieldHashMap
Build an empty map with default size
OpenIntToFieldHashMap(Field<T>, int) - Constructor for class org.apache.commons.math.util.OpenIntToFieldHashMap
Build an empty map with specified size and using zero for missing entries.
OpenIntToFieldHashMap(Field<T>, int, T) - Constructor for class org.apache.commons.math.util.OpenIntToFieldHashMap
Build an empty map with specified size.
OpenIntToFieldHashMap(OpenIntToFieldHashMap<T>) - Constructor for class org.apache.commons.math.util.OpenIntToFieldHashMap
Copy constructor.
OpenIntToFieldHashMap.Iterator - Class in org.apache.commons.math.util
Iterator class for the map.
OpenLongDoubleHashMap - Class in cern.colt.map.tdouble
Hash map holding (key,value) associations of type (int-->double); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenLongDoubleHashMap() - Constructor for class cern.colt.map.tdouble.OpenLongDoubleHashMap
Constructs an empty map with default capacity and default load factors.
OpenLongDoubleHashMap(int) - Constructor for class cern.colt.map.tdouble.OpenLongDoubleHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenLongDoubleHashMap(int, double, double) - Constructor for class cern.colt.map.tdouble.OpenLongDoubleHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenLongFloatHashMap - Class in cern.colt.map.tfloat
Hash map holding (key,value) associations of type (int-->float); Automatically grows and shrinks as needed; Implemented using open addressing with float hashing.
OpenLongFloatHashMap() - Constructor for class cern.colt.map.tfloat.OpenLongFloatHashMap
Constructs an empty map with default capacity and default load factors.
OpenLongFloatHashMap(int) - Constructor for class cern.colt.map.tfloat.OpenLongFloatHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenLongFloatHashMap(int, double, double) - Constructor for class cern.colt.map.tfloat.OpenLongFloatHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenLongIntHashMap - Class in cern.colt.map.tlong
Hash map holding (key,value) associations of type (long-->int); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenLongIntHashMap() - Constructor for class cern.colt.map.tlong.OpenLongIntHashMap
Constructs an empty map with default capacity and default load factors.
OpenLongIntHashMap(int) - Constructor for class cern.colt.map.tlong.OpenLongIntHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenLongIntHashMap(int, double, double) - Constructor for class cern.colt.map.tlong.OpenLongIntHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenLongLongHashMap - Class in cern.colt.map.tlong
Hash map holding (key,value) associations of type (long-->long); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenLongLongHashMap() - Constructor for class cern.colt.map.tlong.OpenLongLongHashMap
Constructs an empty map with default capacity and default load factors.
OpenLongLongHashMap(int) - Constructor for class cern.colt.map.tlong.OpenLongLongHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenLongLongHashMap(int, double, double) - Constructor for class cern.colt.map.tlong.OpenLongLongHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenLongObjectHashMap - Class in cern.colt.map
Hash map holding (key,value) associations of type (long-->Object); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenLongObjectHashMap() - Constructor for class cern.colt.map.OpenLongObjectHashMap
Constructs an empty map with default capacity and default load factors.
OpenLongObjectHashMap(int) - Constructor for class cern.colt.map.OpenLongObjectHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenLongObjectHashMap(int, double, double) - Constructor for class cern.colt.map.OpenLongObjectHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenLongObjectHashMap - Class in cern.colt.map.tobject
Hash map holding (key,value) associations of type (long-->Object); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
OpenLongObjectHashMap() - Constructor for class cern.colt.map.tobject.OpenLongObjectHashMap
Constructs an empty map with default capacity and default load factors.
OpenLongObjectHashMap(int) - Constructor for class cern.colt.map.tobject.OpenLongObjectHashMap
Constructs an empty map with the specified initial capacity and default load factors.
OpenLongObjectHashMap(int, double, double) - Constructor for class cern.colt.map.tobject.OpenLongObjectHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
OpenMapRealMatrix - Class in org.apache.commons.math.linear
Sparse matrix implementation based on an open addressed map.
OpenMapRealMatrix(int, int) - Constructor for class org.apache.commons.math.linear.OpenMapRealMatrix
Build a sparse matrix with the supplied row and column dimensions.
OpenMapRealMatrix(OpenMapRealMatrix) - Constructor for class org.apache.commons.math.linear.OpenMapRealMatrix
Build a matrix by copying another one.
OpenMapRealVector - Class in org.apache.commons.math.linear
This class implements the RealVector interface with a OpenIntToDoubleHashMap backing store.
OpenMapRealVector() - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Build a 0-length vector.
OpenMapRealVector(int) - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Construct a (dimension)-length vector of zeros.
OpenMapRealVector(int, double) - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Construct a (dimension)-length vector of zeros, specifying zero tolerance.
OpenMapRealVector(int, int) - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Build a vector with known the sparseness (for advanced use only).
OpenMapRealVector(int, int, double) - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Build a vector with known the sparseness and zero tolerance setting (for advanced use only).
OpenMapRealVector(double[]) - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Create from a double array.
OpenMapRealVector(double[], double) - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Create from a double array, specifying zero tolerance.
OpenMapRealVector(Double[]) - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Create from a Double array.
OpenMapRealVector(Double[], double) - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Create from a Double array.
OpenMapRealVector(OpenMapRealVector) - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Copy constructor.
OpenMapRealVector(RealVector) - Constructor for class org.apache.commons.math.linear.OpenMapRealVector
Generic copy constructor.
oper(H1D, String) - Method in class jhplot.H1D
Various manipulations with histograms (+,-,*,/).
oper(H1D, String, String) - Method in class jhplot.H1D
Various manipulations with histograms (+,-,*,/).
oper(H2D, String, String) - Method in class jhplot.H2D
Various manipulations with histograms (+,-,*,/).
oper(P0D, String) - Method in class jhplot.P0D
Operations on P0D containers: add, subtract, multiply, divide.
oper(P0D, String, String) - Method in class jhplot.P0D
Operations on P0D containers: add, subtract, multiply, divide.
oper(P0I, String) - Method in class jhplot.P0I
Operations on P0I containers: add, subtract, multiply, divide.
oper(P0I, String, String) - Method in class jhplot.P0I
Operations on P0I containers: add, subtract, multiply, divide.
oper(P1D, String) - Method in class jhplot.P1D
Operations on P1D container: add, subtract, multiply, divide.
oper(P1D, String, String) - Method in class jhplot.P1D
Operations on P1D containers: add, subtract, multiply, divide.
oper(P1D, String, String, String, P1D) - Method in class jhplot.P1D
Operations on P1D containers: add, subtract, multiply, divide.
oper(PND, String) - Method in class jhplot.PND
Operations on PND containers: add, subtract, multiply, divide.
oper(PND, String, String) - Method in class jhplot.PND
Operations on PND containers: add, subtract, multiply, divide.
oper(PNI, String) - Method in class jhplot.PNI
Operations on PNI containers: add, subtract, multiply, divide.
oper(PNI, String, String) - Method in class jhplot.PNI
Operations on PNI containers: add, subtract, multiply, divide.
operate(T[]) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the result of multiplying this by the vector v.
operate(FieldVector<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the result of multiplying this by the vector v.
operate(RealVector) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the result of multiplying this by the vector v.
operate(T[]) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Returns the result of multiplying this by the vector v.
operate(BigDecimal[]) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the result of multiplying this by the vector v.
operate(BigDecimal[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the result of multiplying this by the vector v.
operate(T[]) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the result of multiplying this by the vector v.
operate(T[]) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the result of multiplying this by the vector v.
operate(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result of multiplying this by the vector v.
operate(RealVector) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result of multiplying this by the vector v.
operate(double[]) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Returns the result of multiplying this by the vector v.
operErrSys(String, int, P1D, P1D) - Method in class jhplot.P1D
Obtain a new P1D with 2nd-level errors on X or Y obtained from two P1D objects, one represents left on X (or lower on Y) error and the other represents the right on X (or upper on Y) error.
operScale(String, double) - Method in class jhplot.H1D
Scale the histogram and return scaled object.
operScale(String, double) - Method in class jhplot.H2D
Scale the histogram and return scaled object.
operScale(double) - Method in class jhplot.P0D
Scale P0D with a factor scale.
operScale(Integer) - Method in class jhplot.P0I
Scale P0I with a factor scale.
operScale(int, double) - Method in class jhplot.P1D
Scale X-values (axis=0) or Y values (axis=1) and their errors with a scale factor.
operScale(double) - Method in class jhplot.PND
Scale each element of data
operScale(double) - Method in class jhplot.PNI
Scale each element of data
operScaleErr(int, double) - Method in class jhplot.P1D
Scale 1st level errors with a scale factor.
operScaleErrSys(int, double) - Method in class jhplot.P1D
Scale 2nd level errors with a scale factor.
operShift(double) - Method in class jhplot.P0D
Shift all values in the array by a constant.
operShift(Integer) - Method in class jhplot.P0I
Shift all values in the array by a constant.
operShiftAndScale(double, double) - Method in class jhplot.P0D
Shift all values by a constant "shift", then scale it.
operShiftAndScale(Integer, Integer) - Method in class jhplot.P0I
Shift all values by a constant "shift", then scale it.
operSmooth(boolean, int) - Method in class jhplot.H1D
Smooth the histogram.
operSmooth(boolean, int) - Method in class jhplot.HProf1D
Smooth the histogram.
operSmooth(int, boolean, int) - Method in class jhplot.P1D
Smooth P1D data points in either X or Y.
operSmoothGauss(double) - Method in class jhplot.H1D
Computes a Gaussian smoothed version of the histogram.
operSmoothGauss(double) - Method in class jhplot.HProf1D
Computes a Gaussian smoothed version of the histogram.
operSmoothGauss(int, double) - Method in class jhplot.P1D
Computes a Gaussian smoothed version of P1D.
opposite() - Method in class flanagan.math.Matrix
 
opposite(Matrix) - Static method in class flanagan.math.Matrix
 
oppositeRelationship() - Method in enum org.apache.commons.math.optimization.linear.Relationship
Get the relationship obtained when multiplying all coefficients by -1.
OptimizationException - Exception in org.apache.commons.math.optimization
Deprecated. in 2.2 (to be removed in 3.0).
OptimizationException(String, Object...) - Constructor for exception org.apache.commons.math.optimization.OptimizationException
Deprecated. as of 2.2 replaced by OptimizationException.OptimizationException(Localizable, Object...)
OptimizationException(Localizable, Object...) - Constructor for exception org.apache.commons.math.optimization.OptimizationException
Deprecated. Simple constructor.
OptimizationException(Throwable) - Constructor for exception org.apache.commons.math.optimization.OptimizationException
Deprecated. Create an exception with a given root cause.
optimize(DifferentiableMultivariateRealFunction, GoalType, double[]) - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
Optimizes an objective function.
optimize(DifferentiableMultivariateVectorialFunction, double[], double[], double[]) - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
Optimizes an objective function.
optimize(MultivariateRealFunction, GoalType, double[]) - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Optimizes an objective function.
optimize(DifferentiableMultivariateVectorialFunction, double[], double[], double[]) - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Optimizes an objective function.
optimize(DifferentiableMultivariateRealFunction, GoalType, double[]) - Method in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Optimizes an objective function.
optimize(LinearObjectiveFunction, Collection<LinearConstraint>, GoalType, boolean) - Method in class org.apache.commons.math.optimization.linear.AbstractLinearOptimizer
Optimizes an objective function.
optimize(LinearObjectiveFunction, Collection<LinearConstraint>, GoalType, boolean) - Method in interface org.apache.commons.math.optimization.linear.LinearOptimizer
Optimizes an objective function.
optimize(DifferentiableMultivariateRealFunction, GoalType, double[]) - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Optimizes an objective function.
optimize(DifferentiableMultivariateVectorialFunction, double[], double[], double[]) - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Optimizes an objective function.
optimize(MultivariateRealFunction, GoalType, double[]) - Method in class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Optimizes an objective function.
optimize(UnivariateRealFunction, GoalType, double, double) - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Find an optimum in the given interval.
optimize(UnivariateRealFunction, GoalType, double, double, double) - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Find an optimum in the given interval, start at startValue.
optimize(MultivariateRealFunction, GoalType, double[]) - Method in interface org.apache.commons.math.optimization.MultivariateRealOptimizer
Optimizes an objective function.
optimize(UnivariateRealFunction, GoalType, double, double, double) - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
Find an optimum in the given interval, start at startValue.
optimize(UnivariateRealFunction, GoalType, double, double) - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
Find an optimum in the given interval.
optimize(UnivariateRealFunction, GoalType, double, double) - Method in interface org.apache.commons.math.optimization.UnivariateRealOptimizer
Find an optimum in the given interval.
optimize(UnivariateRealFunction, GoalType, double, double, double) - Method in interface org.apache.commons.math.optimization.UnivariateRealOptimizer
Find an optimum in the given interval, start at startValue.
optimizer() - Method in class hep.aida.ref.fitter.Fitter
 
or(BitMatrix) - Method in class cern.colt.bitvector.BitMatrix
Performs a logical OR of the receiver with another bit matrix.
or(BitVector) - Method in class cern.colt.bitvector.BitVector
Performs a logical OR of the receiver with another bit vector (A = A | B).
or(BitMatrix) - Method in class cern.colt.matrix.tbit.BitMatrix
Performs a logical OR of the receiver with another bit matrix.
or(BitVector) - Method in class cern.colt.matrix.tbit.BitVector
Performs a logical OR of the receiver with another bit vector (A = A | B).
or - Static variable in class cern.jet.math.IntFunctions
Function that returns a | b.
or(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a | b.
or - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a | b.
or(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a | b.
or - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a | b.
or(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a | b.
or(BitMatrix) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Returns the BitMatrix resulting from the application of the or operator on the original BitMatrix and that.
or(BitVector) - Method in class umontreal.iro.lecuyer.util.BitVector
Returns a BitVector which is the result of the or operator with both the this and that BitVector's.
orderedData() - Method in class flanagan.analysis.ProbabilityPlot
 
orderedEigenValues() - Method in class flanagan.analysis.PCA
 
orderedEigenVectors() - Method in class flanagan.analysis.PCA
 
orderedEigenVectorsAsColumns() - Method in class flanagan.analysis.PCA
 
orderedEigenVectorsAsRows() - Method in class flanagan.analysis.PCA
 
orderedScaledTransformedData() - Method in class flanagan.analysis.BoxCox
 
orderedTransformedData() - Method in class flanagan.analysis.BoxCox
 
orderPoints() - Method in class flanagan.interpolation.CubicSpline
 
org.apache.commons.math - package org.apache.commons.math
Common classes used throughout the commons-math library.
org.apache.commons.math.analysis - package org.apache.commons.math.analysis
Parent package for common numerical analysis procedures, including root finding, function interpolation and integration.
org.apache.commons.math.analysis.integration - package org.apache.commons.math.analysis.integration
Numerical integration (quadrature) algorithms for univariate real functions.
org.apache.commons.math.analysis.interpolation - package org.apache.commons.math.analysis.interpolation
Univariate real functions interpolation algorithms.
org.apache.commons.math.analysis.polynomials - package org.apache.commons.math.analysis.polynomials
Univariate real polynomials implementations, seen as differentiable univariate real functions.
org.apache.commons.math.analysis.solvers - package org.apache.commons.math.analysis.solvers
Root finding algorithms, for univariate real functions.
org.apache.commons.math.complex - package org.apache.commons.math.complex
Complex number type and implementations of complex transcendental functions.
org.apache.commons.math.dfp - package org.apache.commons.math.dfp
Decimal floating point library for Java
org.apache.commons.math.distribution - package org.apache.commons.math.distribution
Implementations of common discrete and continuous distributions.
org.apache.commons.math.estimation - package org.apache.commons.math.estimation
This package provided classes to solve estimation problems, it is deprecated since 2.0.
org.apache.commons.math.exception - package org.apache.commons.math.exception
Specialized exceptions for algorithms errors.
org.apache.commons.math.exception.util - package org.apache.commons.math.exception.util
Classes supporting exception localization.
org.apache.commons.math.fraction - package org.apache.commons.math.fraction
Fraction number type and fraction number formatting.
org.apache.commons.math.genetics - package org.apache.commons.math.genetics
This package provides Genetic Algorithms components and implementations.
org.apache.commons.math.geometry - package org.apache.commons.math.geometry
This package provides basic 3D geometry components.
org.apache.commons.math.linear - package org.apache.commons.math.linear
Linear algebra support.
org.apache.commons.math.ode - package org.apache.commons.math.ode
This package provides classes to solve Ordinary Differential Equations problems.
org.apache.commons.math.ode.events - package org.apache.commons.math.ode.events
This package provides classes to handle discrete events occurring during Ordinary Differential Equations integration.
org.apache.commons.math.ode.jacobians - package org.apache.commons.math.ode.jacobians
This package was intended to solve Ordinary Differential Equations problems and also compute derivatives of the solution.
org.apache.commons.math.ode.nonstiff - package org.apache.commons.math.ode.nonstiff
This package provides classes to solve non-stiff Ordinary Differential Equations problems.
org.apache.commons.math.ode.sampling - package org.apache.commons.math.ode.sampling
This package provides classes to handle sampling steps during Ordinary Differential Equations integration.
org.apache.commons.math.optimization - package org.apache.commons.math.optimization
This package provides common interfaces for the optimization algorithms provided in sub-packages.
org.apache.commons.math.optimization.direct - package org.apache.commons.math.optimization.direct
This package provides optimization algorithms that don't require derivatives.
org.apache.commons.math.optimization.fitting - package org.apache.commons.math.optimization.fitting
This package provides classes to perform curve fitting.
org.apache.commons.math.optimization.general - package org.apache.commons.math.optimization.general
This package provides optimization algorithms that require derivatives.
org.apache.commons.math.optimization.linear - package org.apache.commons.math.optimization.linear
This package provides optimization algorithms for linear constrained problems.
org.apache.commons.math.optimization.univariate - package org.apache.commons.math.optimization.univariate
Univariate real functions minimum finding algorithms.
org.apache.commons.math.random - package org.apache.commons.math.random
Random number and random data generators.
org.apache.commons.math.special - package org.apache.commons.math.special
Implementations of special functions such as Beta and Gamma.
org.apache.commons.math.stat - package org.apache.commons.math.stat
Data storage, manipulation and summary routines.
org.apache.commons.math.stat.clustering - package org.apache.commons.math.stat.clustering
Clustering algorithms
org.apache.commons.math.stat.correlation - package org.apache.commons.math.stat.correlation
Correlations/Covariance computations.
org.apache.commons.math.stat.descriptive - package org.apache.commons.math.stat.descriptive
Generic univariate summary statistic objects.
org.apache.commons.math.stat.descriptive.moment - package org.apache.commons.math.stat.descriptive.moment
Summary statistics based on moments.
org.apache.commons.math.stat.descriptive.rank - package org.apache.commons.math.stat.descriptive.rank
Summary statistics based on ranks.
org.apache.commons.math.stat.descriptive.summary - package org.apache.commons.math.stat.descriptive.summary
Other summary statistics.
org.apache.commons.math.stat.inference - package org.apache.commons.math.stat.inference
Classes providing hypothesis testing and confidence interval construction.
org.apache.commons.math.stat.ranking - package org.apache.commons.math.stat.ranking
Classes providing rank transformations.
org.apache.commons.math.stat.regression - package org.apache.commons.math.stat.regression
Statistical routines involving multivariate data.
org.apache.commons.math.transform - package org.apache.commons.math.transform
Implementations of transform methods, including Fast Fourier transforms.
org.apache.commons.math.util - package org.apache.commons.math.util
Convenience routines and common data structures used throughout the commons-math library.
org.netlib.arpack - package org.netlib.arpack
 
org.netlib.blas - package org.netlib.blas
 
org.netlib.generate - package org.netlib.generate
 
org.netlib.lapack - package org.netlib.lapack
 
org.netlib.utils - package org.netlib.utils
 
ORIENTATION_HORIZONTAL - Static variable in class umontreal.iro.lecuyer.charts.Axis
 
ORIENTATION_VERTICAL - Static variable in class umontreal.iro.lecuyer.charts.Axis
 
originalArrayTypes() - Method in class flanagan.math.ArrayMaths
 
originalCorrelationCoefficient() - Method in class flanagan.analysis.BoxCox
 
originalData() - Method in class flanagan.analysis.BoxCox
 
originalData() - Method in class flanagan.analysis.PCA
 
originalErrors() - Method in class flanagan.analysis.RankAnalysis
 
originalExcessKurtosis() - Method in class flanagan.analysis.BoxCox
 
originalGradient() - Method in class flanagan.analysis.BoxCox
 
originalIndices() - Method in class flanagan.math.ArrayMaths
 
originalIntercept() - Method in class flanagan.analysis.BoxCox
 
originalItemNames() - Method in class flanagan.analysis.Scores
 
originalMaximum() - Method in class flanagan.analysis.BoxCox
 
originalMean() - Method in class flanagan.analysis.BoxCox
 
originalMedian() - Method in class flanagan.analysis.BoxCox
 
originalMedianSkewness() - Method in class flanagan.analysis.BoxCox
 
originalMinimum() - Method in class flanagan.analysis.BoxCox
 
originalMomentSkewness() - Method in class flanagan.analysis.BoxCox
 
originalNumberOfItems() - Method in class flanagan.analysis.Scores
 
originalNumberOfPersons() - Method in class flanagan.analysis.Scores
 
originalProbabilityPlot() - Method in class flanagan.analysis.BoxCox
 
originalQuartiletSkewness() - Method in class flanagan.analysis.BoxCox
 
originalRange() - Method in class flanagan.analysis.BoxCox
 
originalResponses() - Method in class flanagan.analysis.Scores
 
originalResponsesAsRowPerItem() - Method in class flanagan.analysis.Scores
 
originalResponsesAsRowPerPerson() - Method in class flanagan.analysis.Scores
 
originalScores() - Method in class flanagan.analysis.Scores
 
originalScoresAsRowPerItem() - Method in class flanagan.analysis.Scores
 
originalScoresAsRowPerPerson() - Method in class flanagan.analysis.Scores
 
originalStandardDeviation() - Method in class flanagan.analysis.BoxCox
 
originalStandardError() - Method in class flanagan.analysis.BoxCox
 
originalTotalNumberOfScores() - Method in class flanagan.analysis.Scores
 
originalValues() - Method in class flanagan.analysis.RankAnalysis
 
originalVariance() - Method in class flanagan.analysis.BoxCox
 
OrnsteinUhlenbeckProcess - Class in umontreal.iro.lecuyer.stochprocess
This class represents an Ornstein-Uhlenbeck process {X(t) : t >= 0}, sampled at times 0 = t0 < t1 < ...
OrnsteinUhlenbeckProcess(double, double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Constructs a new OrnsteinUhlenbeckProcess with parameters α = alpha, b, σ = sigma and initial value X(t0) = x0.
OrnsteinUhlenbeckProcess(double, double, double, double, NormalGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Here, the normal variate generator is specified directly instead of specifying the stream.
OrnsteinUhlenbeckProcessEuler - Class in umontreal.iro.lecuyer.stochprocess
.
OrnsteinUhlenbeckProcessEuler(double, double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcessEuler
Constructor with parameters α = alpha, b, σ = sigma and initial value X(t0) = x0.
OrnsteinUhlenbeckProcessEuler(double, double, double, double, NormalGen) - Constructor for class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcessEuler
Here, the normal variate generator is specified directly instead of specifying the stream.
orot - Variable in class jhplot.v3d.Canvas3d
 
orthogonal() - Method in class org.apache.commons.math.geometry.Vector3D
Get a vector orthogonal to the instance.
OS - Static variable in class org.netlib.utils.JNIMethods
Stores the operating system the JVM is currently running on.
OS_ARCH - Static variable in class jhplot.HPlotJa
The architecture of the current operating system.
OS_NAME - Static variable in class jhplot.HPlotJa
The name of the current operating system.
OS_VERSION - Static variable in class jhplot.HPlotJa
The version of the current operating system.
oscale - Variable in class jhplot.v3d.Canvas3d
 
otherDichotomousData(String, String) - Method in class flanagan.analysis.Scores
 
otrans - Variable in class jhplot.v3d.Canvas3d
 
ounceToGram(double) - Static method in class flanagan.math.Conv
 
ounceToGram(double) - Static method in class flanagan.math.Fmath
 
outerProduct(RealVector) - Method in class org.apache.commons.math.linear.AbstractRealVector
Compute the outer product.
outerProduct(double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Compute the outer product.
outerProduct(FieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute the outer product.
outerProduct(ArrayFieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute the outer product.
outerProduct(T[]) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute the outer product.
outerProduct(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Compute the outer product.
outerProduct(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Compute the outer product.
outerProduct(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Compute the outer product.
outerProduct(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldVector
Compute the outer product.
outerProduct(T[]) - Method in interface org.apache.commons.math.linear.FieldVector
Compute the outer product.
outerProduct(double[]) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Compute the outer product.
outerProduct(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Compute the outer product.
outerProduct(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Compute the outer product.
outerProduct(SparseFieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Optimized method to compute outer product when both vectors are sparse.
outerProduct(T[]) - Method in class org.apache.commons.math.linear.SparseFieldVector
Compute the outer product.
outerProduct(FieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Compute the outer product.
OutOfRangeException - Exception in org.apache.commons.math.exception
Exception to be thrown when some argument is out of range.
OutOfRangeException(Number, Number, Number) - Constructor for exception org.apache.commons.math.exception.OutOfRangeException
Construct an exception from the mismatched dimensions.
outputWeight() - Method in class jhplot.bsom.Bsom
 
outputWeightP1D() - Method in class jhplot.bsom.Bsom
Return results
over(ErrorProp, double) - Method in class flanagan.analysis.ErrorProp
 
over(ErrorProp, ErrorProp, double) - Static method in class flanagan.analysis.ErrorProp
 
over(ErrorProp) - Method in class flanagan.analysis.ErrorProp
 
over(ErrorProp, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
over(double) - Method in class flanagan.analysis.ErrorProp
 
over(double, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
over(double, double) - Static method in class flanagan.analysis.ErrorProp
 
over(double) - Method in class flanagan.analysis.Stat
 
over(float) - Method in class flanagan.analysis.Stat
 
over(long) - Method in class flanagan.analysis.Stat
 
over(int) - Method in class flanagan.analysis.Stat
 
over(short) - Method in class flanagan.analysis.Stat
 
over(byte) - Method in class flanagan.analysis.Stat
 
over(BigDecimal) - Method in class flanagan.analysis.Stat
 
over(BigInteger) - Method in class flanagan.analysis.Stat
 
over(Complex) - Method in class flanagan.analysis.Stat
 
over(Phasor) - Method in class flanagan.analysis.Stat
 
over(Double) - Method in class flanagan.analysis.Stat
 
over(Float) - Method in class flanagan.analysis.Stat
 
over(Long) - Method in class flanagan.analysis.Stat
 
over(Integer) - Method in class flanagan.analysis.Stat
 
over(Short) - Method in class flanagan.analysis.Stat
 
over(Byte) - Method in class flanagan.analysis.Stat
 
over(double) - Method in class flanagan.math.ArrayMaths
 
over(Double) - Method in class flanagan.math.ArrayMaths
 
over(float) - Method in class flanagan.math.ArrayMaths
 
over(Float) - Method in class flanagan.math.ArrayMaths
 
over(long) - Method in class flanagan.math.ArrayMaths
 
over(Long) - Method in class flanagan.math.ArrayMaths
 
over(int) - Method in class flanagan.math.ArrayMaths
 
over(Integer) - Method in class flanagan.math.ArrayMaths
 
over(short) - Method in class flanagan.math.ArrayMaths
 
over(Short) - Method in class flanagan.math.ArrayMaths
 
over(BigDecimal) - Method in class flanagan.math.ArrayMaths
 
over(byte) - Method in class flanagan.math.ArrayMaths
 
over(Byte) - Method in class flanagan.math.ArrayMaths
 
over(BigInteger) - Method in class flanagan.math.ArrayMaths
 
over(Complex) - Method in class flanagan.math.ArrayMaths
 
over(Phasor) - Method in class flanagan.math.ArrayMaths
 
over(Matrix) - Method in class flanagan.math.Matrix
 
over(Matrix, Matrix) - Method in class flanagan.math.Matrix
 
over(double[][]) - Method in class flanagan.math.Matrix
 
over(Matrix, double[][]) - Method in class flanagan.math.Matrix
 
over(double[][], Matrix) - Method in class flanagan.math.Matrix
 
over(double[][], double[][]) - Method in class flanagan.math.Matrix
 
overEquals(ErrorProp) - Method in class flanagan.analysis.ErrorProp
 
overEquals(ErrorProp, double) - Method in class flanagan.analysis.ErrorProp
 
overEquals(double) - Method in class flanagan.analysis.ErrorProp
 
overEquals(Matrix) - Method in class flanagan.math.Matrix
 
overEquals(double[][]) - Method in class flanagan.math.Matrix
 
OVERFLOW - Static variable in interface hep.aida.tdouble.DoubleIHistogram
Constant specifying the overflow bin (can be passed to any method expecting a bin number).
OVERFLOW - Static variable in interface hep.aida.tfloat.FloatIHistogram
Constant specifying the overflow bin (can be passed to any method expecting a bin number).

P

P0 - Class in jhplot.fit
Polynomial 0-order (p0)
P0() - Constructor for class jhplot.fit.P0
 
P0(String) - Constructor for class jhplot.fit.P0
 
P0(String[], String[]) - Constructor for class jhplot.fit.P0
 
P0D - Class in jhplot
A container to hold data points in one dimension.
P0D(String) - Constructor for class jhplot.P0D
Construct an empty container with a title
P0D(DoubleArrayList) - Constructor for class jhplot.P0D
Construct P0D from DoubleArrayList from cern.colt.list.DoubleArrayList;
P0D(double[]) - Constructor for class jhplot.P0D
Construct P0D from array;
P0D(String, double[]) - Constructor for class jhplot.P0D
Create P0D from an array.
P0D(int[]) - Constructor for class jhplot.P0D
Construct P0D from an integer array.
P0D(String, int[]) - Constructor for class jhplot.P0D
Construct P0D from integers.
P0D(String, boolean, P0D) - Constructor for class jhplot.P0D
Construct a copy from a P0D.
P0D() - Constructor for class jhplot.P0D
Construct an empty container with a title
P0D(String, String) - Constructor for class jhplot.P0D
Construct a P0D from a file.
P0I - Class in jhplot
A container to hold data points in one dimension.
P0I(String) - Constructor for class jhplot.P0I
Construct an empty container with a title
P0I(IntArrayList) - Constructor for class jhplot.P0I
Construct P0I from IntegerArrayList from cern.colt.list.IntegerArrayList;
P0I(Integer[]) - Constructor for class jhplot.P0I
Construct P0I from array;
P0I(String, int[]) - Constructor for class jhplot.P0I
Create P0I from an array.
P0I(int[]) - Constructor for class jhplot.P0I
Construct P0I from an integer array.
P0I(String, Integer[]) - Constructor for class jhplot.P0I
Construct P0I from integers.
P0I(String, boolean, P0I) - Constructor for class jhplot.P0I
Construct a copy from a P0I.
P0I() - Constructor for class jhplot.P0I
Construct an empty container with a title
P0I(String, String) - Constructor for class jhplot.P0I
Construct a P0I from a file.
P1 - Class in jhplot.fit
Polynomial 1-order (p0+p1*x)
P1() - Constructor for class jhplot.fit.P1
 
P1(String) - Constructor for class jhplot.fit.P1
 
P1(String[], String[]) - Constructor for class jhplot.fit.P1
 
P1D - Class in jhplot
A container to hold data points with 1st and 2nd level errors.
P1D(String) - Constructor for class jhplot.P1D
Construct an empty container with a title
P1D(String, int) - Constructor for class jhplot.P1D
Construct an empty container with a title
P1D(String, Color) - Constructor for class jhplot.P1D
Construct an empty container with a title and color for points
P1D(String, Color, int) - Constructor for class jhplot.P1D
Construct an empty container with a title and color and symbol style for points
P1D(P0D, P0D) - Constructor for class jhplot.P1D
Construct a container from pairs of P0D (one for X, second for Y)
P1D(String, P0D, P0D) - Constructor for class jhplot.P1D
Construct a container from pairs of P0D (one for X, second for Y)
P1D(Cloud2D) - Constructor for class jhplot.P1D
Construct P1D from a Cloud2D
P1D(String, double[], double[]) - Constructor for class jhplot.P1D
Construct a container from pairs X and Y
P1D(String, boolean, P1D) - Constructor for class jhplot.P1D
Construct a new copy
P1D(DataHolder, String, int, int) - Constructor for class jhplot.P1D
Create P1D data holder from multidimensional data holder.
P1D(DataHolder, int, int) - Constructor for class jhplot.P1D
Create P1D data holder from multidimensional data holder.
P1D(String, String) - Constructor for class jhplot.P1D
Construct a P1D from a file.
P1D(IDataPointSet) - Constructor for class jhplot.P1D
Create a P1D container from IDataPointSet.
P1D(String, H1D, boolean, boolean) - Constructor for class jhplot.P1D
Create a P1D container from a histogram
P1D(H1D, boolean, boolean) - Constructor for class jhplot.P1D
Create a P1D container from a histogram.
P1D(String, H1D, boolean) - Constructor for class jhplot.P1D
Create a P1D container from a histogram.
P1D(H1D, boolean) - Constructor for class jhplot.P1D
Create a P1D container from a histogram.
P1D(H1D) - Constructor for class jhplot.P1D
Create a P1D container from a histogram.
P1D(String, H1D) - Constructor for class jhplot.P1D
Create a P1D container from a histogram.
P1D(String, URL) - Constructor for class jhplot.P1D
Construct a P1D from a file on the we web.
P1D(URL) - Constructor for class jhplot.P1D
Construct a P1D from a file on the we web.
p1evl(double, double[], int) - Static method in class cern.jet.math.Polynomial
Evaluates the given polynomial of degree N at x, assuming coefficient of N is 1.0.
p1evl(double, double[], int) - Static method in class cern.jet.math.tdouble.Polynomial
Evaluates the given polynomial of degree N at x, assuming coefficient of N is 1.0.
P2 - Class in jhplot.fit
Polynomial 2-order (p0+p1*x+p2*x*x)
P2() - Constructor for class jhplot.fit.P2
 
P2(String) - Constructor for class jhplot.fit.P2
 
P2(String[], String[]) - Constructor for class jhplot.fit.P2
 
P2D - Class in jhplot
A container to hold data points in X,Y,Z.
P2D(String) - Constructor for class jhplot.P2D
Construct an empty container with a title
P2D() - Constructor for class jhplot.P2D
Construct an empty container with a title
P2D(String, String) - Constructor for class jhplot.P2D
Construct a P2D from a file.
P3 - Class in jhplot.fit
Polynomial 3rd-order.
P3() - Constructor for class jhplot.fit.P3
 
P3(String) - Constructor for class jhplot.fit.P3
 
P3(String[], String[]) - Constructor for class jhplot.fit.P3
 
P3D - Class in jhplot
A container to hold data points in X,Y,Z and their extensions dX,dY,dZ.
P3D(String) - Constructor for class jhplot.P3D
Construct an empty container with a title
P3D() - Constructor for class jhplot.P3D
Construct an empty container with a title
P3D(String, String) - Constructor for class jhplot.P3D
Construct a P3D from a file.
P4 - Class in jhplot.fit
Polynomial 4th-order.
P4() - Constructor for class jhplot.fit.P4
 
P4(String) - Constructor for class jhplot.fit.P4
 
P4(String[], String[]) - Constructor for class jhplot.fit.P4
 
P5 - Class in jhplot.fit
Polynomial 5th-order.
P5() - Constructor for class jhplot.fit.P5
 
P5(String) - Constructor for class jhplot.fit.P5
 
P5(String[], String[]) - Constructor for class jhplot.fit.P5
 
P6 - Class in jhplot.fit
Polynomial 6th-order.
P6() - Constructor for class jhplot.fit.P6
 
P6(String) - Constructor for class jhplot.fit.P6
 
P6(String[], String[]) - Constructor for class jhplot.fit.P6
 
PaddedPointSet - Class in umontreal.iro.lecuyer.hups
This container class realizes padded point sets, constructed by taking some coordinates from a point set P1, other coordinates from a point set P2, and so on.
PaddedPointSet(int) - Constructor for class umontreal.iro.lecuyer.hups.PaddedPointSet
Constructs a structure for padding at most maxPointSets point sets.
padding(int, int, double[]) - Static method in class jhplot.math.ArrayMathUtils
Fills in with zero to get to the desired length; original array with be at the specified position.
padding(int, int, int[]) - Static method in class jhplot.math.ArrayMathUtils
Fills in with zeroes to get to the specified length; original array with be at the specified position
padPointSet(PointSet) - Method in class umontreal.iro.lecuyer.hups.PaddedPointSet
Pads the point set P to the present structure.
padPointSetPermute(PointSet) - Method in class umontreal.iro.lecuyer.hups.PaddedPointSet
Pads the point set P, which is assumed to be finite.
paint(Graphics) - Method in class flanagan.math.FourierTransform
 
paint(Graphics) - Method in class jhplot.v3d.Animation
 
paint(Graphics) - Method in class jhplot.v3d.Canvas3d
 
pairedT(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
pairedT(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a paired, 2-sample t-statistic based on the data in the input arrays.
pairedT(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a paired, 2-sample t-statistic based on the data in the input arrays.
pairedTTest(double[], double[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
pairedTTest(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
pairedTTest(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a paired, two-sample, two-tailed t-test based on the data in the input arrays.
pairedTTest(double[], double[], double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a paired t-test evaluating the null hypothesis that the mean of the paired differences between sample1 and sample2 is 0 in favor of the two-sided alternative that the mean paired difference is not equal to 0, with significance level alpha.
pairedTTest(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a paired, two-sample, two-tailed t-test based on the data in the input arrays.
pairedTTest(double[], double[], double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a paired t-test evaluating the null hypothesis that the mean of the paired differences between sample1 and sample2 is 0 in favor of the two-sided alternative that the mean paired difference is not equal to 0, with significance level alpha.
pairsMatching(DoubleIntProcedure, DoubleArrayList, IntArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntDoubleProcedure, IntArrayList, DoubleArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntIntProcedure, IntArrayList, IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntObjectProcedure, IntArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongObjectProcedure, LongArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(DoubleIntProcedure, DoubleArrayList, IntArrayList) - Method in class cern.colt.map.OpenDoubleIntHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntDoubleProcedure, IntArrayList, DoubleArrayList) - Method in class cern.colt.map.OpenIntDoubleHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntIntProcedure, IntArrayList, IntArrayList) - Method in class cern.colt.map.OpenIntIntHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntObjectProcedure, IntArrayList, ObjectArrayList) - Method in class cern.colt.map.OpenIntObjectHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongObjectProcedure, LongArrayList, ObjectArrayList) - Method in class cern.colt.map.OpenLongObjectHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(DoubleIntProcedure, DoubleArrayList, IntArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(DoubleLongProcedure, DoubleArrayList, LongArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntDoubleProcedure, IntArrayList, DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongDoubleProcedure, LongArrayList, DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(DoubleIntProcedure, DoubleArrayList, IntArrayList) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(DoubleLongProcedure, DoubleArrayList, LongArrayList) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntDoubleProcedure, IntArrayList, DoubleArrayList) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongDoubleProcedure, LongArrayList, DoubleArrayList) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(FloatIntProcedure, FloatArrayList, IntArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(FloatLongProcedure, FloatArrayList, LongArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntFloatProcedure, IntArrayList, FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongFloatProcedure, LongArrayList, FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(FloatIntProcedure, FloatArrayList, IntArrayList) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(FloatLongProcedure, FloatArrayList, LongArrayList) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntFloatProcedure, IntArrayList, FloatArrayList) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongFloatProcedure, LongArrayList, FloatArrayList) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntIntProcedure, IntArrayList, IntArrayList) - Method in class cern.colt.map.tint.AbstractIntIntMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntIntProcedure, IntArrayList, IntArrayList) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntLongProcedure, IntArrayList, LongArrayList) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongIntProcedure, LongArrayList, IntArrayList) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongLongProcedure, LongArrayList, LongArrayList) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntLongProcedure, IntArrayList, LongArrayList) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongIntProcedure, LongArrayList, IntArrayList) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongLongProcedure, LongArrayList, LongArrayList) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntObjectProcedure, IntArrayList, ObjectArrayList) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongObjectProcedure, LongArrayList, ObjectArrayList) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(IntObjectProcedure, IntArrayList, ObjectArrayList) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsMatching(LongObjectProcedure, LongArrayList, ObjectArrayList) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Fills all pairs satisfying a given condition into the specified lists.
pairsSortedByKey(DoubleArrayList, IntArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, DoubleArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(LongArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(DoubleArrayList, IntArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(DoubleArrayList, LongArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(LongArrayList, DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(FloatArrayList, IntArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(FloatArrayList, LongArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(LongArrayList, FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, IntArrayList) - Method in class cern.colt.map.tint.AbstractIntIntMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, LongArrayList) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(LongArrayList, IntArrayList) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(LongArrayList, LongArrayList) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(IntArrayList, ObjectArrayList) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByKey(LongArrayList, ObjectArrayList) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Fills all keys and values sorted ascending by key into the specified lists.
pairsSortedByValue(DoubleArrayList, IntArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, DoubleArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all keys and values sorted ascending by value according to natural ordering into the specified lists.
pairsSortedByValue(LongArrayList, ObjectArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all keys and values sorted ascending by value according to natural ordering into the specified lists.
pairsSortedByValue(DoubleArrayList, IntArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(DoubleArrayList, LongArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(LongArrayList, DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(FloatArrayList, IntArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(FloatArrayList, LongArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(LongArrayList, FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, IntArrayList) - Method in class cern.colt.map.tint.AbstractIntIntMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, LongArrayList) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(LongArrayList, IntArrayList) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(LongArrayList, LongArrayList) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Fills all keys and values sorted ascending by value into the specified lists.
pairsSortedByValue(IntArrayList, ObjectArrayList) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Fills all keys and values sorted ascending by value according to natural ordering into the specified lists.
pairsSortedByValue(LongArrayList, ObjectArrayList) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Fills all keys and values sorted ascending by value according to natural ordering into the specified lists.
palmSunday() - Method in class flanagan.math.TimeAndDate
 
palmSunday(int) - Method in class flanagan.math.TimeAndDate
 
ParallelQuickSort - Class in cern.colt
Multithreaded implementation of quicksort.
ParallelQuickSort() - Constructor for class cern.colt.ParallelQuickSort
 
parallelQuickSort(byte[], int, int, ByteComparator) - Static method in class cern.colt.Sorting
Multithreaded quicksort
parallelQuickSort(char[], int, int, CharComparator) - Static method in class cern.colt.Sorting
Multithreaded quicksort
parallelQuickSort(double[], int, int, DoubleComparator) - Static method in class cern.colt.Sorting
Multithreaded quicksort
parallelQuickSort(float[], int, int, FloatComparator) - Static method in class cern.colt.Sorting
Multithreaded quicksort
parallelQuickSort(int[], int, int, IntComparator) - Static method in class cern.colt.Sorting
Multithreaded quicksort
parallelQuickSort(long[], int, int, LongComparator) - Static method in class cern.colt.Sorting
Multithreaded quicksort
parallelQuickSort(Object[]) - Static method in class cern.colt.Sorting
Multithreaded quicksort
parallelQuickSort(Object[], Comparator) - Static method in class cern.colt.Sorting
Multithreaded quicksort
parallelQuickSort(Object[], int, int) - Static method in class cern.colt.Sorting
Multithreaded quicksort
parallelQuickSort(Object[], int, int, Comparator) - Static method in class cern.colt.Sorting
Multithreaded quicksort
parallelQuickSort(short[], int, int, ShortComparator) - Static method in class cern.colt.Sorting
Multithreaded quicksort
param(String, String) - Method in class jhplot.v3d.Model3d
 
param(String, boolean) - Method in class jhplot.v3d.Model3d
 
param(String, int) - Method in class jhplot.v3d.Model3d
 
param(String, float) - Method in class jhplot.v3d.Model3d
 
parameter(String) - Method in class hep.aida.ref.fitter.InternalFitFunction
 
parameter(String) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
parameter(String) - Method in class hep.aida.ref.function.AbstractIFunction
 
parameter(String) - Method in class hep.aida.ref.function.BaseModelFunction
 
parameter(String) - Method in class hep.aida.ref.function.FunctionCore
 
parameter(String) - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
parameter(String) - Method in class hep.aida.ref.function.SumOfFunctions
 
PARAMETER_NAME_CHANGED - Static variable in class hep.aida.ref.function.FunctionChangedEvent
 
PARAMETER_VALUE_CHANGED - Static variable in class hep.aida.ref.function.FunctionChangedEvent
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.AbstractIFunction
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.BaseModelFunction
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.ExponentialCoreNorm
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.ExponentialCoreNotNorm
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.FunctionCore
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.GaussianCore2DNorm
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.GaussianCore2DNotNorm
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.GaussianCoreNorm
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.GaussianCoreNotNorm
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.JELFunctionCore
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.LorentzianCoreNotNorm
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.MoyalCoreNotNorm
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.PolynomialCoreNorm
 
parameterGradient(double[]) - Method in class hep.aida.ref.function.PolynomialCoreNotNorm
 
ParameterizedODE - Interface in org.apache.commons.math.ode.jacobians
Deprecated. as of 2.2 the complete package is deprecated, it will be replaced in 3.0 by a completely rewritten implementation
parameterNames() - Method in class hep.aida.ref.fitter.InternalFitFunction
 
parameterNames() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
parameterNames() - Method in class hep.aida.ref.function.AbstractIFunction
 
parameterNames() - Method in class hep.aida.ref.function.BaseModelFunction
 
parameterNames() - Method in class hep.aida.ref.function.FunctionCore
 
parameterNames() - Method in class hep.aida.ref.function.SumOfFunctions
 
parameters() - Method in class hep.aida.ref.fitter.InternalFitFunction
 
parameters() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
parameters() - Method in class hep.aida.ref.function.AbstractIFunction
 
parameters() - Method in class hep.aida.ref.function.BaseModelFunction
 
parameters() - Method in class hep.aida.ref.function.FunctionCore
 
parameters() - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
parameters() - Method in class hep.aida.ref.function.SumOfFunctions
 
ParametricGaussianFunction - Class in org.apache.commons.math.optimization.fitting
A Gaussian function.
ParametricGaussianFunction() - Constructor for class org.apache.commons.math.optimization.fitting.ParametricGaussianFunction
Constructs an instance.
ParametricRealFunction - Interface in org.apache.commons.math.optimization.fitting
An interface representing a real function that depends on one independent variable plus some extra parameters.
PArc(float, float, float, float, float, float) - Static method in class jhplot.jadraw.Diagram
 
pareto() - Method in class flanagan.analysis.Regression
 
pareto(double, double, double) - Static method in class flanagan.analysis.Stat
 
paretoAlpha() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoAlphaError() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoArray(double, double, int) - Method in class flanagan.math.PsRandom
 
paretoBeta() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoBetaError() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
paretoCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
paretoCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
ParetoDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for a distribution from the Pareto family, with shape parameter α > 0 and location parameter β > 0.
ParetoDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.ParetoDist
Constructs a ParetoDist object with parameters α = alpha and β = 1.
ParetoDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.ParetoDist
Constructs a ParetoDist object with parameters α = alpha and β = beta.
ParetoGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for one of the Pareto distributions, with parameters α > 0 and β > 0.
ParetoGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.ParetoGen
Creates a Pareto random variate generator with parameters α = alpha and β = beta, using stream s.
ParetoGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.ParetoGen
Creates a Pareto random variate generator with parameters α = alpha and β = 1, using stream s.
ParetoGen(RandomStream, ParetoDist) - Constructor for class umontreal.iro.lecuyer.randvar.ParetoGen
Creates a new generator for the Pareto distribution dist and stream s.
paretoGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
paretoMean(double, double) - Static method in class flanagan.analysis.Stat
 
paretoMode(double) - Static method in class flanagan.analysis.Stat
 
paretoOnePar() - Method in class flanagan.analysis.Regression
 
paretoOneParPlot() - Method in class flanagan.analysis.Regression
 
paretoOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
paretoPDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
paretoPlot() - Method in class flanagan.analysis.Regression
 
paretoProb(double, double, double) - Static method in class flanagan.analysis.Stat
 
paretoProb(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
paretoProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoRand(double, double, int) - Static method in class flanagan.analysis.Stat
 
paretoRand(double, double, int, long) - Static method in class flanagan.analysis.Stat
 
paretoShifted() - Method in class flanagan.analysis.Regression
 
paretoShiftedPlot() - Method in class flanagan.analysis.Regression
 
paretoStandardDeviation(double, double) - Static method in class flanagan.analysis.Stat
 
paretoStandDev(double, double) - Static method in class flanagan.analysis.Stat
 
paretoSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
paretoThreePar() - Method in class flanagan.analysis.Regression
 
paretoThreeParPlot() - Method in class flanagan.analysis.Regression
 
paretoTwoPar() - Method in class flanagan.analysis.Regression
 
paretoTwoParPlot() - Method in class flanagan.analysis.Regression
 
parkMiller() - Method in class flanagan.math.PsRandom
 
parse() - Method in class hep.aida.ref.function.JELCompiledExpression
 
parse() - Method in class jhplot.F1D
Parse the function.
parse(MappingStrategy, Reader) - Method in class jhplot.io.csv.bean.CsvToBean
 
parse(String) - Method in class org.apache.commons.math.complex.ComplexFormat
Parses a string to produce a Complex object.
parse(String, ParsePosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Parses a string to produce a Complex object.
parse(String) - Method in class org.apache.commons.math.fraction.BigFractionFormat
Parses a string to produce a BigFraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math.fraction.BigFractionFormat
Parses a string to produce a BigFraction object.
parse(String) - Method in class org.apache.commons.math.fraction.FractionFormat
Parses a string to produce a Fraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math.fraction.FractionFormat
Parses a string to produce a Fraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math.fraction.ProperBigFractionFormat
Parses a string to produce a BigFraction object.
parse(String, ParsePosition) - Method in class org.apache.commons.math.fraction.ProperFractionFormat
Parses a string to produce a Fraction object.
parse(String) - Method in class org.apache.commons.math.geometry.Vector3DFormat
Parses a string to produce a Vector3D object.
parse(String, ParsePosition) - Method in class org.apache.commons.math.geometry.Vector3DFormat
Parses a string to produce a Vector3D object.
parse(String) - Method in class org.apache.commons.math.linear.RealVectorFormat
Parses a string to produce a RealVector object.
parse(String, ParsePosition) - Method in class org.apache.commons.math.linear.RealVectorFormat
Parses a string to produce a RealVector object.
parseContour() - Method in class jhplot.jadraw.JaAxes
Prepare a contour plot
parseDirName(String) - Static method in class hep.aida.ref.AidaUtils
 
parseH2D() - Method in class jhplot.jadraw.JaAxes
Prepare a contour plot to display H2D histograms
parseInt(String) - Method in class hep.aida.ref.function.JELCompiledExpression
 
parseName(String) - Static method in class hep.aida.ref.AidaUtils
 
parseObject(String, ParsePosition) - Method in class org.apache.commons.math.complex.ComplexFormat
Parses a string to produce a object.
parseObject(String, ParsePosition) - Method in class org.apache.commons.math.geometry.Vector3DFormat
Parses a string to produce a object.
parseObject(String, ParsePosition) - Method in class org.apache.commons.math.linear.RealVectorFormat
Parses a string to produce a object.
parseOptions(String) - Static method in class hep.aida.ref.AidaUtils
Parse AIDA options.
parseString(String) - Static method in class hep.aida.ref.AidaUtils
 
part(int, int, int, int) - Method in class cern.colt.bitvector.BitMatrix
Constructs and returns a new matrix with width columns and height rows which is a copy of the contents of the given box.
part(int, int, int, int) - Method in class cern.colt.matrix.tbit.BitMatrix
Constructs and returns a new matrix with width columns and height rows which is a copy of the contents of the given box.
partFromTo(int, int) - Method in class cern.colt.bitvector.BitVector
Constructs and returns a new bit vector which is a copy of the given range.
partFromTo(int, int) - Method in class cern.colt.list.AbstractBooleanList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractByteList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractCharList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractDoubleList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractFloatList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractIntList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractLongList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.AbstractShortList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.ByteArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.CharArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.DoubleArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.FloatArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.IntArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.LongArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int, BitVector, int, long[], int) - Method in class cern.colt.list.MinMaxNumberList
Copies all elements between index from (inclusive) and to (inclusive) into part, starting at index partFrom within part.
partFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.ShortArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tbyte.ByteArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tchar.CharArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tdouble.DoubleArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tfloat.FloatArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tint.AbstractIntList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tint.IntArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tlong.LongArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int, BitVector, int, long[], int) - Method in class cern.colt.list.tlong.MinMaxNumberList
Copies all elements between index from (inclusive) and to (inclusive) into part, starting at index partFrom within part.
partFromTo(int, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.list.tshort.ShortArrayList
Returns a new list of the part of the receiver between from, inclusive, and to, inclusive.
partFromTo(int, int) - Method in class cern.colt.matrix.tbit.BitVector
Constructs and returns a new bit vector which is a copy of the given range.
partialDerivative(int) - Method in interface org.apache.commons.math.analysis.DifferentiableMultivariateRealFunction
Returns the partial derivative of the function with respect to a point coordinate.
partialDerivativeX(double, double) - Method in class org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolatingFunction
 
partialDerivativeXX(double, double) - Method in class org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolatingFunction
 
partialDerivativeXY(double, double) - Method in class org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolatingFunction
 
partialDerivativeY(double, double) - Method in class org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolatingFunction
 
partialDerivativeYY(double, double) - Method in class org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolatingFunction
 
partition(DoubleMatrix2D, int[], int, int, int, double[], int, int, int[]) - Static method in class cern.colt.matrix.doublealgo.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(DoubleMatrix2D, int, double[], int[]) - Static method in class cern.colt.matrix.doublealgo.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(ObjectMatrix2D, int[], int, int, int, Object[], int, int, int[]) - Static method in class cern.colt.matrix.objectalgo.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(ObjectMatrix2D, int, Object[], int[]) - Static method in class cern.colt.matrix.objectalgo.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(DoubleMatrix2D, int[], int, int, int, double[], int, int, int[]) - Static method in class cern.colt.matrix.tdouble.algo.DoublePartitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(DoubleMatrix2D, int, double[], int[]) - Static method in class cern.colt.matrix.tdouble.algo.DoublePartitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(FloatMatrix2D, int[], int, int, int, float[], int, int, int[]) - Static method in class cern.colt.matrix.tfloat.algo.FloatPartitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(FloatMatrix2D, int, float[], int[]) - Static method in class cern.colt.matrix.tfloat.algo.FloatPartitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(ObjectMatrix2D, int[], int, int, int, Object[], int, int, int[]) - Static method in class cern.colt.matrix.tobject.algo.ObjectPartitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(ObjectMatrix2D, int, Object[], int[]) - Static method in class cern.colt.matrix.tobject.algo.ObjectPartitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it synchronously partitions the rows of the given matrix by the values of the given matrix column; This is essentially the same as partitioning a list of composite objects by some instance variable; In other words, two entire rows of the matrix are swapped, whenever two column values indicate so.
partition(double[], int, int, double[], int, int, int[]) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it partitions double[] rather than int[] arrays.
partition(double[], int, int, double) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int) except that it partitions double[] rather than int[] arrays.
partition(int[], int, int, int[], int, int, int[]) - Static method in class cern.colt.Partitioning
Partitions (partially sorts) the given list such that all elements falling into some intervals are placed next to each other.
partition(int[], int, int, int) - Static method in class cern.colt.Partitioning
Partitions (partially sorts) the given list such that all elements falling into the given interval are placed next to each other.
partition(Object[], int, int, Object[], int, int, int[], Comparator) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that it partitions Object[] rather than int[] arrays.
partition(Object[], int, int, Object, Comparator) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int) except that it synchronously partitions the objects of the given list by the order of the given comparator.
partition(DoubleArrayList, int, int, DoubleArrayList, IntArrayList) - Static method in class cern.colt.Partitioning
Equivalent to partition(list.elements(), from, to, splitters.elements(), 0, splitters.size()-1, splitIndexes.elements()) .
partition(IntArrayList, int, int, IntArrayList, IntArrayList) - Static method in class cern.colt.Partitioning
Equivalent to partition(list.elements(), from, to, splitters.elements(), 0, splitters.size()-1, splitIndexes.elements()) .
Partition - Class in jminhep.cluster
Interface class to all clustering algorithms.
Partition(DataHolder) - Constructor for class jminhep.cluster.Partition
 
Partitioning - Class in cern.colt.matrix.doublealgo
Given some interval boundaries, partitions matrices such that cell values falling into an interval are placed next to each other.
Partitioning - Class in cern.colt.matrix.objectalgo
Given some interval boundaries, partitions matrices such that cell values falling into an interval are placed next to each other.
Partitioning - Class in cern.colt
Given some interval boundaries, partitions arrays such that all elements falling into an interval are placed next to each other.
pascal - Static variable in class cern.clhep.Units
 
PascalConvolutionGen - Class in umontreal.iro.lecuyer.randvar
Implements Pascal random variate generators by the convolution method.
PascalConvolutionGen(RandomStream, int, double) - Constructor for class umontreal.iro.lecuyer.randvar.PascalConvolutionGen
Creates a Pascal random variate generator with parameters n and p, using stream s.
PascalConvolutionGen(RandomStream, PascalDist) - Constructor for class umontreal.iro.lecuyer.randvar.PascalConvolutionGen
Creates a new generator for the distribution dist, using stream s.
PascalDist - Class in umontreal.iro.lecuyer.probdist
The Pascal distribution is a special case of the negative binomial distribution with parameters n and p, where n is a positive integer and 0 <= p <= 1.
PascalDist(int, double) - Constructor for class umontreal.iro.lecuyer.probdist.PascalDist
Creates an object that contains the probability terms and the distribution function for the Pascal distribution with parameter n and p.
PascalDistribution - Interface in org.apache.commons.math.distribution
The Pascal distribution.
PascalDistributionImpl - Class in org.apache.commons.math.distribution
The default implementation of PascalDistribution.
PascalDistributionImpl(int, double) - Constructor for class org.apache.commons.math.distribution.PascalDistributionImpl
Create a Pascal distribution with the given number of trials and probability of success.
PascalGen - Class in umontreal.iro.lecuyer.randvar
Implements Pascal random variate generators, which is a special case of the negative binomial generator with parameter γ equal to a positive integer.
PascalGen(RandomStream, int, double) - Constructor for class umontreal.iro.lecuyer.randvar.PascalGen
Creates a Pascal random variate generator with parameters n and p, using stream s.
PascalGen(RandomStream, PascalDist) - Constructor for class umontreal.iro.lecuyer.randvar.PascalGen
Creates a new generator for the distribution dist, using stream s.
pathNameOfPath(String) - Static method in class jhplot.v3d.Util
 
PCA - Class in flanagan.analysis
 
PCA() - Constructor for class flanagan.analysis.PCA
 
pca() - Method in class flanagan.analysis.PCA
 
PCA - Class in jhplot.stat
Perform a principle component analysis
PCA(double[][]) - Constructor for class jhplot.stat.PCA
Initialize 2D PCA analysis
PCA(P1D) - Constructor for class jhplot.stat.PCA
Perform PCA analysis using P1D object (in 2D).
PCADecompose(double[][], double[][], double[]) - Static method in class umontreal.iro.lecuyer.util.DMatrix
Computes the principal components decomposition M = UΛUt by using the singular value decomposition of matrix M.
PCADecompose(DoubleMatrix2D, double[]) - Static method in class umontreal.iro.lecuyer.util.DMatrix
Computes the principal components decomposition M = UΛUt by using the singular value decomposition of matrix M.
pdf(double) - Method in class cern.jet.random.Beta
Returns the cumulative distribution function.
pdf(int) - Method in class cern.jet.random.Binomial
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.ChiSquare
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.Empirical
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.Empirical
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.EmpiricalWalker
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.Exponential
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.Gamma
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.HyperGeometric
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.NegativeBinomial
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.Normal
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.Poisson
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.StudentT
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.tdouble.Beta
Returns the cumulative distribution function.
pdf(int) - Method in class cern.jet.random.tdouble.Binomial
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.tdouble.ChiSquare
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.tdouble.DoubleUniform
Returns the probability distribution function (assuming a continous uniform distribution).
pdf(double) - Method in class cern.jet.random.tdouble.Empirical
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.tdouble.Empirical
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.tdouble.EmpiricalWalker
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.tdouble.Exponential
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.tdouble.Gamma
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.tdouble.HyperGeometric
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.tdouble.NegativeBinomial
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.tdouble.Normal
Returns the probability distribution function.
pdf(int) - Method in class cern.jet.random.tdouble.Poisson
Returns the probability distribution function.
pdf(double) - Method in class cern.jet.random.tdouble.StudentT
Returns the probability distribution function.
pdf(float) - Method in class cern.jet.random.tfloat.FloatUniform
Returns the probability distribution function (assuming a continous uniform distribution).
pdf(double) - Method in class cern.jet.random.Uniform
Returns the probability distribution function (assuming a continous uniform distribution).
pDisc(double, double) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Computes a variant of the p-value p whenever a test statistic has a discrete probability distribution.
Pearson5Dist - Class in umontreal.iro.lecuyer.probdist
THIS CLASS HAS BEEN RENAMED InverseGammaDist.
Pearson5Dist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.Pearson5Dist
THIS CLASS HAS BEEN RENAMED InverseGammaDist.
Pearson5Gen - Class in umontreal.iro.lecuyer.randvar
THIS CLASS HAS BEEN RENAMED InverseGammaGen.
Pearson5Gen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.Pearson5Gen
THIS CLASS HAS BEEN RENAMED InverseGammaGen.
Pearson5Gen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.Pearson5Gen
Creates a Pearson5 random variate generator with parameters α = alpha and β = 1, using stream s.
Pearson5Gen(RandomStream, Pearson5Dist) - Constructor for class umontreal.iro.lecuyer.randvar.Pearson5Gen
Creates a new generator for the distribution dist, using stream s.
Pearson6Dist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Pearson type VI distribution with shape parameters α1 > 0 and α2 > 0, and scale parameter β > 0.
Pearson6Dist(double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.Pearson6Dist
Constructs a Pearson6Dist object with parameters α1 = alpha1, α2 = alpha2 and β = beta.
Pearson6Gen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the Pearson type VI distribution with shape parameters α1 > 0 and α2 > 0, and scale parameter β > 0.
Pearson6Gen(RandomStream, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.Pearson6Gen
Creates a Pearson6 random variate generator with parameters α1 = alpha1, α2 = alpha2 and β = beta, using stream s.
Pearson6Gen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.Pearson6Gen
Creates a Pearson6 random variate generator with parameters α1 = alpha1, α2 = alpha2 and β = 1, using stream s.
Pearson6Gen(RandomStream, Pearson6Dist) - Constructor for class umontreal.iro.lecuyer.randvar.Pearson6Gen
Creates a new generator for the distribution dist, using stream s.
PearsonsCorrelation - Class in org.apache.commons.math.stat.correlation
Computes Pearson's product-moment correlation coefficients for pairs of arrays or columns of a matrix.
PearsonsCorrelation() - Constructor for class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation instance without data
PearsonsCorrelation(double[][]) - Constructor for class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a rectangular array whose columns represent values of variables to be correlated.
PearsonsCorrelation(RealMatrix) - Constructor for class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a RealMatrix whose columns represent variables to be correlated.
PearsonsCorrelation(Covariance) - Constructor for class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a Covariance.
PearsonsCorrelation(RealMatrix, int) - Constructor for class org.apache.commons.math.stat.correlation.PearsonsCorrelation
Create a PearsonsCorrelation from a covariance matrix.
perCent - Static variable in class cern.clhep.Units
 
percentageValue() - Method in class org.apache.commons.math.fraction.BigFraction
Gets the fraction percentage as a double.
percentFromTo(float, float) - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns the percentage of elements in the range (from,to].
percentFromTo(double, double) - Method in class cern.jet.stat.tdouble.quantile.DoubleEquiDepthHistogram
Returns the percentage of elements in the range (from,to].
percentFromTo(float, float) - Method in class cern.jet.stat.tfloat.quantile.FloatEquiDepthHistogram
Returns the percentage of elements in the range (from,to].
percentile(double[], double) - Static method in class jhplot.math.ArrayMathUtils
Gives the percentile of an array
percentile(int[], double) - Static method in class jhplot.math.ArrayMathUtils
Gives the percentile of an array.
Percentile - Class in org.apache.commons.math.stat.descriptive.rank
Provides percentile computation.
Percentile() - Constructor for class org.apache.commons.math.stat.descriptive.rank.Percentile
Constructs a Percentile with a default quantile value of 50.0.
Percentile(double) - Constructor for class org.apache.commons.math.stat.descriptive.rank.Percentile
Constructs a Percentile with the specific quantile value.
Percentile(Percentile) - Constructor for class org.apache.commons.math.stat.descriptive.rank.Percentile
Copy constructor, creates a new Percentile identical to the original
percentile(double[], double) - Static method in class org.apache.commons.math.stat.StatUtils
Returns an estimate of the pth percentile of the values in the values array.
percentile(double[], int, int, double) - Static method in class org.apache.commons.math.stat.StatUtils
Returns an estimate of the pth percentile of the values in the values array, starting with the element in (0-based) position begin in the array and including length values.
percentWeightByVolToMolar(double, double) - Static method in class flanagan.math.Conv
 
percentWeightByVolToMolar(double, double) - Static method in class flanagan.math.Fmath
 
perMillion - Static variable in class cern.clhep.Units
 
permutation(long, int) - Static method in class cern.colt.GenericPermuting
Returns the p-th permutation of the sequence [0,1,...,N-1].
PermutationChromosome<T> - Interface in org.apache.commons.math.genetics
Interface indicating that the chromosome represents a permutation of objects.
permute(int[], int[]) - Static method in class cern.colt.GenericPermuting
A non-generic variant of reordering, specialized for int[], same semantics.
permute(int[], Swapper, int[]) - Static method in class cern.colt.GenericPermuting
Deprecated.  
permute(int[], Swapper, int[], int[]) - Static method in class cern.colt.GenericPermuting
Generically reorders arbitrary shaped generic data g such that g[i] == g[indexes[i]].
permute(Object[], int[]) - Static method in class cern.colt.GenericPermuting
A non-generic variant of reordering, specialized for Object[], same semantics.
permute(DoubleMatrix1D, int[], double[]) - Method in class cern.colt.matrix.linalg.Algebra
Modifies the given vector A such that it is permuted as specified; Useful for pivoting.
permute(DoubleMatrix2D, int[], int[]) - Method in class cern.colt.matrix.linalg.Algebra
Constructs and returns a new row and column permuted selection view of matrix A; equivalent to DoubleMatrix2D.viewSelection(int[],int[]).
permute(DoubleMatrix1D, int[], double[]) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Modifies the given vector A such that it is permuted as specified; Useful for pivoting.
permute(DoubleMatrix2D, int[], int[]) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Constructs and returns a new row and column permuted selection view of matrix A; equivalent to DoubleMatrix2D.viewSelection(int[],int[]).
permute(FloatMatrix1D, int[], float[]) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Modifies the given vector A such that it is permuted as specified; Useful for pivoting.
permute(FloatMatrix2D, int[], int[]) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Constructs and returns a new row and column permuted selection view of matrix A; equivalent to FloatMatrix2D.viewSelection(int[],int[]).
permute(int[], Object[], boolean) - Static method in class jhplot.math.SortUtils
Rearrange the specified data according to the specified permutation.
permuteColumns(DoubleMatrix2D, int[], int[]) - Method in class cern.colt.matrix.linalg.Algebra
Modifies the given matrix A such that it's columns are permuted as specified; Useful for pivoting.
permuteColumns(DoubleMatrix2D, int[], int[]) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Modifies the given matrix A such that it's columns are permuted as specified; Useful for pivoting.
permuteColumns(FloatMatrix2D, int[], int[]) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Modifies the given matrix A such that it's columns are permuted as specified; Useful for pivoting.
permutedRadicalInverse(int, int[], int) - Static method in class umontreal.iro.lecuyer.hups.RadicalInverse
Computes the radical inverse of i in base b, where the digits are permuted using the permutation π.
permuteRows(DoubleMatrix2D, int[], int[]) - Method in class cern.colt.matrix.linalg.Algebra
Modifies the given matrix A such that it's rows are permuted as specified; Useful for pivoting.
permuteRows(DoubleMatrix2D, int[], int[]) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Modifies the given matrix A such that it's rows are permuted as specified; Useful for pivoting.
permuteRows(FloatMatrix2D, int[], int[]) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Modifies the given matrix A such that it's rows are permuted as specified; Useful for pivoting.
perp() - Method in class hephysics.vec.Hep3Vector
Transverse
perp() - Method in class hephysics.vec.HepLorentzVector
Transverse momentum.
perp2() - Method in class hephysics.vec.Hep3Vector
Transverse
perp2() - Method in class hephysics.vec.HepLorentzVector
Transverse momentum squared
PersistentObject - Class in cern.colt
This empty class is the common root for all persistent capable classes.
persp - Variable in class jhplot.v3d.Model3d
 
perThousand - Static variable in class cern.clhep.Units
 
petaelectronvolt - Static variable in class cern.clhep.Units
 
PeV - Static variable in class cern.clhep.Units
 
PFile - Class in jhplot.io
Write or read objects in sequential order using Google's Prototype Buffer scheme.
PFile(String, String, boolean) - Constructor for class jhplot.io.PFile
Open a file to write/read objects to/from a file in sequential order.
PFile(String) - Constructor for class jhplot.io.PFile
Open file for reading objects from a serialized file in sequential order.
PFile(String, String) - Constructor for class jhplot.io.PFile
Open file for reading objects from a serialized file in sequential order.
PFileBrowser - Class in jhplot.io
A GUI to browser data stored in a PFile format (extension "pbu").
PFileBrowser(HPlot, PFile, boolean) - Constructor for class jhplot.io.PFileBrowser
Open PFile file in a pop-up window to browser it and check all objects
phi(double) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Returns how many percent of the elements contained in the receiver are <= element.
phi(float) - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns how many percent of the elements contained in the receiver are <= element.
phi(double) - Method in class cern.jet.stat.tdouble.quantile.DoubleEquiDepthHistogram
Returns how many percent of the elements contained in the receiver are <= element.
phi(double) - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Returns how many percent of the elements contained in the receiver are <= element.
phi(double) - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Returns how many percent of the elements contained in the receiver are <= element.
phi(float) - Method in class cern.jet.stat.tfloat.quantile.FloatEquiDepthHistogram
Returns how many percent of the elements contained in the receiver are <= element.
phi(float) - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Returns how many percent of the elements contained in the receiver are <= element.
phi() - Method in class hephysics.vec.Hep3Vector
Phi
phi() - Method in class hephysics.vec.HepLorentzVector
Phi
phi() - Method in class hephysics.vec.SpacePoint
Cylindrical phi
phi(Hep3Vector) - Static method in class hephysics.vec.VecOp
 
PhysicalConstants - Class in cern.clhep
High Energy Physics coherent Physical Constants.
physicalConstants - Static variable in class cern.clhep.PhysicalConstants
Little trick to allow for "aliasing", that is, renaming this class.
pi - Static variable in class cern.clhep.PhysicalConstants
 
PI - Static variable in class flanagan.math.Fmath
 
PI - Static variable in class org.apache.commons.math.util.FastMath
Archimede's constant PI, ratio of circle circumference to diameter.
pi2 - Static variable in class cern.clhep.PhysicalConstants
 
PI_2 - Static variable in interface jhplot.math.num.Constants
2 π.
picobarn - Static variable in class cern.clhep.Units
 
picofarad - Static variable in class cern.clhep.Units
 
picosecond - Static variable in class cern.clhep.Units
 
Picture - Class in jhplot.shapes
Insert a picture in the PNG or GIF format.
Picture(double, double, String) - Constructor for class jhplot.shapes.Picture
Create a picture object in the USER coordinates
Picture(double, double, Image) - Constructor for class jhplot.shapes.Picture
Create a picture object in the USER coordinates
PiecewiseConstantFunction - Class in umontreal.iro.lecuyer.functions
Represents a piecewise-constant function.
PiecewiseConstantFunction(double[], double[]) - Constructor for class umontreal.iro.lecuyer.functions.PiecewiseConstantFunction
Constructs a new piecewise-constant function with X and Y coordinates given by x and y.
PiecewiseLinearEmpiricalDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for a piecewise-linear approximation of the empirical distribution function, based on the observations X(1),..., X(n) (sorted by increasing order), and defined as follows (e.g.,).
PiecewiseLinearEmpiricalDist(double[]) - Constructor for class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
Constructs a new piecewise-linear distribution using all the observations stored in obs.
PiecewiseLinearEmpiricalDist(Reader) - Constructor for class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
Constructs a new empirical distribution using the observations read from the reader in.
pintToLitre(double) - Static method in class flanagan.math.Conv
 
pintToLitre(double) - Static method in class flanagan.math.Fmath
 
pintUKtoCupUS(double) - Static method in class flanagan.math.Conv
 
pintUKtoCupUS(double) - Static method in class flanagan.math.Fmath
 
pintUKtoUS(double) - Static method in class flanagan.math.Conv
 
pintUKtoUS(double) - Static method in class flanagan.math.Fmath
 
pintUStoUK(double) - Static method in class flanagan.math.Conv
 
pintUStoUK(double) - Static method in class flanagan.math.Fmath
 
pivot() - Method in class flanagan.math.Matrix
 
PLAIN - Static variable in class umontreal.iro.lecuyer.util.TableFormat
Plain text matrix printing style
PLine(float, float) - Static method in class jhplot.jadraw.Diagram
Get a photon line object
PLoop(float, float) - Static method in class jhplot.jadraw.Diagram
Get a photon loop object
plot(int) - Method in class flanagan.math.ArrayMaths
 
plotCorrelation() - Method in class flanagan.math.FourierTransform
 
plotCorrelation(String) - Method in class flanagan.math.FourierTransform
 
PlotFormat - Class in umontreal.iro.lecuyer.charts
Provide tools to import and export data set tables to and from Gnuplot, MATLAB and Mathematica compatible formats, or customized format.
plotPowerLog(int) - Method in class flanagan.math.FourierTransform
 
plotPowerLog(int, String) - Method in class flanagan.math.FourierTransform
 
plotPowerLog(int, int) - Method in class flanagan.math.FourierTransform
 
plotPowerLog(int, int, String) - Method in class flanagan.math.FourierTransform
 
plotPowerLog(double) - Method in class flanagan.math.FourierTransform
 
plotPowerLog(double, String) - Method in class flanagan.math.FourierTransform
 
plotPowerLog(double, double) - Method in class flanagan.math.FourierTransform
 
plotPowerLog(double, double, String) - Method in class flanagan.math.FourierTransform
 
plotPowerLog() - Method in class flanagan.math.FourierTransform
 
plotPowerLog(String) - Method in class flanagan.math.FourierTransform
 
plotPowerSpectrum(int) - Method in class flanagan.math.FourierTransform
 
plotPowerSpectrum(int, String) - Method in class flanagan.math.FourierTransform
 
plotPowerSpectrum(int, int) - Method in class flanagan.math.FourierTransform
 
plotPowerSpectrum(int, int, String) - Method in class flanagan.math.FourierTransform
 
plotPowerSpectrum(double) - Method in class flanagan.math.FourierTransform
 
plotPowerSpectrum(double, String) - Method in class flanagan.math.FourierTransform
 
plotPowerSpectrum(double, double) - Method in class flanagan.math.FourierTransform
 
plotPowerSpectrum(double, double, String) - Method in class flanagan.math.FourierTransform
 
plotPowerSpectrum() - Method in class flanagan.math.FourierTransform
 
plotPowerSpectrum(String) - Method in class flanagan.math.FourierTransform
 
plotShortTime(String) - Method in class flanagan.math.FourierTransform
 
plotShortTime() - Method in class flanagan.math.FourierTransform
 
plotXY() - Method in class flanagan.analysis.Regression
 
plotXYfixed(Object, String) - Method in class flanagan.analysis.Regression
 
plotXYnonlinear(Object, String) - Method in class flanagan.analysis.Regression
 
plotYY(String) - Method in class flanagan.analysis.Regression
 
plotYY() - Method in class flanagan.analysis.Regression
 
plus(DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A + s <=> A[i] = A[i] + s.
plus(DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A + B <=> A[i] = A[i] + B[i].
plus(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A + s <=> A[row,col] = A[row,col] + s.
plus(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A + B <=> A[row,col] = A[row,col] + B[row,col].
plus(Timer) - Method in class cern.colt.Timer
T = this + other; Constructs and returns a new timer which is the sum of the receiver and the other timer.
plus - Static variable in class cern.jet.math.Functions
Function that returns a + b.
plus(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a + b.
plus - Static variable in class cern.jet.math.IntFunctions
Function that returns a + b.
plus(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a + b.
plus(double[], double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
plus - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
plus(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
plus - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a + b.
plus(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a + b.
plus(float[], float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
plus - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
plus(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
plus - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a + b.
plus(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a + b.
plus - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a + b.
plus(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a + b.
plus - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a + b.
plus(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a + b.
plus(ErrorProp, double) - Method in class flanagan.analysis.ErrorProp
 
plus(ErrorProp, ErrorProp, double) - Static method in class flanagan.analysis.ErrorProp
 
plus(ErrorProp) - Method in class flanagan.analysis.ErrorProp
 
plus(ErrorProp, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
plus(double) - Method in class flanagan.analysis.ErrorProp
 
plus(double, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
plus(double, double) - Static method in class flanagan.analysis.ErrorProp
 
plus(double) - Method in class flanagan.analysis.Stat
 
plus(float) - Method in class flanagan.analysis.Stat
 
plus(long) - Method in class flanagan.analysis.Stat
 
plus(int) - Method in class flanagan.analysis.Stat
 
plus(short) - Method in class flanagan.analysis.Stat
 
plus(byte) - Method in class flanagan.analysis.Stat
 
plus(char) - Method in class flanagan.analysis.Stat
 
plus(BigDecimal) - Method in class flanagan.analysis.Stat
 
plus(BigInteger) - Method in class flanagan.analysis.Stat
 
plus(Complex) - Method in class flanagan.analysis.Stat
 
plus(Phasor) - Method in class flanagan.analysis.Stat
 
plus(String) - Method in class flanagan.analysis.Stat
 
plus(Double) - Method in class flanagan.analysis.Stat
 
plus(Float) - Method in class flanagan.analysis.Stat
 
plus(Long) - Method in class flanagan.analysis.Stat
 
plus(Integer) - Method in class flanagan.analysis.Stat
 
plus(Short) - Method in class flanagan.analysis.Stat
 
plus(Byte) - Method in class flanagan.analysis.Stat
 
plus(Character) - Method in class flanagan.analysis.Stat
 
plus(Stat) - Method in class flanagan.analysis.Stat
 
plus(ArrayMaths) - Method in class flanagan.analysis.Stat
 
plus(ArrayList<Object>) - Method in class flanagan.analysis.Stat
 
plus(Vector<Object>) - Method in class flanagan.analysis.Stat
 
plus(double[]) - Method in class flanagan.analysis.Stat
 
plus(float[]) - Method in class flanagan.analysis.Stat
 
plus(long[]) - Method in class flanagan.analysis.Stat
 
plus(int[]) - Method in class flanagan.analysis.Stat
 
plus(short[]) - Method in class flanagan.analysis.Stat
 
plus(byte[]) - Method in class flanagan.analysis.Stat
 
plus(char[]) - Method in class flanagan.analysis.Stat
 
plus(BigDecimal[]) - Method in class flanagan.analysis.Stat
 
plus(BigInteger[]) - Method in class flanagan.analysis.Stat
 
plus(Complex[]) - Method in class flanagan.analysis.Stat
 
plus(Phasor[]) - Method in class flanagan.analysis.Stat
 
plus(String[]) - Method in class flanagan.analysis.Stat
 
plus(Double[]) - Method in class flanagan.analysis.Stat
 
plus(Float[]) - Method in class flanagan.analysis.Stat
 
plus(Long[]) - Method in class flanagan.analysis.Stat
 
plus(Integer[]) - Method in class flanagan.analysis.Stat
 
plus(Short[]) - Method in class flanagan.analysis.Stat
 
plus(Byte[]) - Method in class flanagan.analysis.Stat
 
plus(Character[]) - Method in class flanagan.analysis.Stat
 
plus(double) - Method in class flanagan.math.ArrayMaths
 
plus(Double) - Method in class flanagan.math.ArrayMaths
 
plus(double[]) - Method in class flanagan.math.ArrayMaths
 
plus(Double[]) - Method in class flanagan.math.ArrayMaths
 
plus(float) - Method in class flanagan.math.ArrayMaths
 
plus(Float) - Method in class flanagan.math.ArrayMaths
 
plus(float[]) - Method in class flanagan.math.ArrayMaths
 
plus(Float[]) - Method in class flanagan.math.ArrayMaths
 
plus(long) - Method in class flanagan.math.ArrayMaths
 
plus(Long) - Method in class flanagan.math.ArrayMaths
 
plus(long[]) - Method in class flanagan.math.ArrayMaths
 
plus(Long[]) - Method in class flanagan.math.ArrayMaths
 
plus(int) - Method in class flanagan.math.ArrayMaths
 
plus(Integer) - Method in class flanagan.math.ArrayMaths
 
plus(int[]) - Method in class flanagan.math.ArrayMaths
 
plus(Integer[]) - Method in class flanagan.math.ArrayMaths
 
plus(short) - Method in class flanagan.math.ArrayMaths
 
plus(Short) - Method in class flanagan.math.ArrayMaths
 
plus(short[]) - Method in class flanagan.math.ArrayMaths
 
plus(Short[]) - Method in class flanagan.math.ArrayMaths
 
plus(BigDecimal) - Method in class flanagan.math.ArrayMaths
 
plus(byte) - Method in class flanagan.math.ArrayMaths
 
plus(Byte) - Method in class flanagan.math.ArrayMaths
 
plus(byte[]) - Method in class flanagan.math.ArrayMaths
 
plus(Byte[]) - Method in class flanagan.math.ArrayMaths
 
plus(BigDecimal[]) - Method in class flanagan.math.ArrayMaths
 
plus(BigInteger) - Method in class flanagan.math.ArrayMaths
 
plus(BigInteger[]) - Method in class flanagan.math.ArrayMaths
 
plus(Complex) - Method in class flanagan.math.ArrayMaths
 
plus(Complex[]) - Method in class flanagan.math.ArrayMaths
 
plus(Phasor) - Method in class flanagan.math.ArrayMaths
 
plus(Phasor[]) - Method in class flanagan.math.ArrayMaths
 
plus(String) - Method in class flanagan.math.ArrayMaths
 
plus(String[]) - Method in class flanagan.math.ArrayMaths
 
plus(char) - Method in class flanagan.math.ArrayMaths
 
plus(char[]) - Method in class flanagan.math.ArrayMaths
 
plus(Character) - Method in class flanagan.math.ArrayMaths
 
plus(Character[]) - Method in class flanagan.math.ArrayMaths
 
plus(Vector<Object>) - Method in class flanagan.math.ArrayMaths
 
plus(ArrayList<Object>) - Method in class flanagan.math.ArrayMaths
 
plus(ArrayMaths) - Method in class flanagan.math.ArrayMaths
 
plus(Stat) - Method in class flanagan.math.ArrayMaths
 
plus(Matrix) - Method in class flanagan.math.Matrix
 
plus(double[][]) - Method in class flanagan.math.Matrix
 
plus(Matrix, Matrix) - Static method in class flanagan.math.Matrix
 
plus(Complex) - Method in class jhplot.math.Complex
Addition of Complex numbers (doesn't change this Complex number).
plus(double[]...) - Static method in class jhplot.math.LinearAlgebra
Element-wise sum of any number of arrays.
plus(double[], double) - Static method in class jhplot.math.LinearAlgebra
Add a scalar value to each element of an array.
plus(double[][], double[][]) - Static method in class jhplot.math.LinearAlgebra
Element-wise sum of two matrices
plus(double[][], double) - Static method in class jhplot.math.LinearAlgebra
Add a scalar to each element of a matrix.
plus(ValueErr, double) - Method in class jhplot.math.ValueErr
Add 2 values with correlation
plus(ValueErr, ValueErr, double) - Static method in class jhplot.math.ValueErr
Adding 2 values with correlation
plus(ValueErr) - Method in class jhplot.math.ValueErr
Add a ValueErr number to this ValueErr number without correlaton
plus(ValueErr, ValueErr) - Static method in class jhplot.math.ValueErr
Add two ValueErr numbers with no correlation
plus(double) - Method in class jhplot.math.ValueErr
Add an error free double number to this ValueErr number
plus(double, ValueErr) - Static method in class jhplot.math.ValueErr
Add a ValueErr number to an error free double
plus(double, double) - Static method in class jhplot.math.ValueErr
Add an error free double number to an error free double and return sum
PLUS_I - Static variable in class org.apache.commons.math.geometry.Vector3D
First canonical vector (coordinates: 1, 0, 0).
PLUS_INF() - Method in class hep.aida.ref.function.RangeSet
 
PLUS_J - Static variable in class org.apache.commons.math.geometry.Vector3D
Second canonical vector (coordinates: 0, 1, 0).
PLUS_K - Static variable in class org.apache.commons.math.geometry.Vector3D
Third canonical vector (coordinates: 0, 0, 1).
plusAbs - Static variable in class cern.jet.math.Functions
Function that returns Math.abs(a) + Math.abs(b).
plusAbs - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.abs(a) + Math.abs(b).
plusAbs - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.abs(a) + Math.abs(b).
plusAbs - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns Math.abs(a) + Math.abs(b).
plusAbs - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns Math.abs(a) + Math.abs(b).
plusDiv(double) - Static method in class cern.jet.math.PlusMult
a + b/constant.
plusDiv(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexPlusMultFirst
a + b/constant.
plusDiv(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexPlusMultSecond
a + b/constant.
plusDiv(double) - Static method in class cern.jet.math.tdouble.DoublePlusMultFirst
a + b/constant.
plusDiv(double) - Static method in class cern.jet.math.tdouble.DoublePlusMultSecond
a + b/constant.
plusDiv(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexPlusMultFirst
a + b/constant.
plusDiv(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexPlusMultSecond
a + b/constant.
plusDiv(float) - Static method in class cern.jet.math.tfloat.FloatPlusMultFirst
a/constant + b.
plusDiv(float) - Static method in class cern.jet.math.tfloat.FloatPlusMultSecond
a + b/constant.
plusEquals(ErrorProp, double) - Method in class flanagan.analysis.ErrorProp
 
plusEquals(ErrorProp) - Method in class flanagan.analysis.ErrorProp
 
plusEquals(double) - Method in class flanagan.analysis.ErrorProp
 
plusEquals(Matrix) - Method in class flanagan.math.Matrix
 
plusEquals(ValueErr, double) - Method in class jhplot.math.ValueErr
Add a ValueErr number to this ValueErr number and replace this with the sum using a correlation
plusEquals(ValueErr) - Method in class jhplot.math.ValueErr
Add a ValueErr number to this ValueErr number and replace this with the sum without correlation
plusEquals(double) - Method in class jhplot.math.ValueErr
Add double number to this ValueErr number and replace this with the sum
plusError(int, double) - Method in interface hep.aida.ref.dataset.binner.BinError
Get the plus error on a bin.
plusError(int[]) - Method in interface hep.aida.ref.dataset.binner.Binner
Get the plus error on a bin.
plusError(int[]) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Get the plus error on a bin.
plusError(int, double) - Method in class hep.aida.ref.dataset.binner.EfficiencyBinError
Get the plus error on a bin.
plusError(int, double) - Method in class hep.aida.ref.dataset.binner.GaussianBinError
Get the plus error on a bin.
plusError(int, double) - Method in class hep.aida.ref.dataset.binner.PoissonBinError
Get the plus error on a bin.
plusError(int) - Method in class hep.aida.ref.histogram.binner.BasicBinner1D
 
plusError(int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
plusError(int, int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
plusError(int) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
plusError(int, int) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
plusError(int, int, int) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
plusError(int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner1D
 
plusError(int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
plusError(int, int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
plusMult(DoubleMatrix1D, DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A + B*s<=> A[i] = A[i] + B[i]*s.
plusMult(DoubleMatrix2D, DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = A + B*s <=> A[row,col] = A[row,col] + B[row,col]*s.
plusMult(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns a + b*constant.
PlusMult - Class in cern.jet.math
Only for performance tuning of compute intensive linear algebraic computations.
plusMult(double) - Static method in class cern.jet.math.PlusMult
a + b*constant.
plusMult(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexPlusMultFirst
a + b*constant.
plusMult(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexPlusMultSecond
a + b*constant.
plusMult(double) - Static method in class cern.jet.math.tdouble.DoublePlusMultFirst
a + b*constant.
plusMult(double) - Static method in class cern.jet.math.tdouble.DoublePlusMultSecond
a + b*constant.
plusMult(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexPlusMultFirst
a + b*constant.
plusMult(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexPlusMultSecond
a + b*constant.
plusMult(float) - Static method in class cern.jet.math.tfloat.FloatPlusMultFirst
a*constant + b.
plusMult(float) - Static method in class cern.jet.math.tfloat.FloatPlusMultSecond
a + b*constant.
plusMult(int) - Static method in class cern.jet.math.tint.IntPlusMultFirst
a + b*constant.
plusMult(int) - Static method in class cern.jet.math.tint.IntPlusMultSecond
a + b*constant.
plusMult(long) - Static method in class cern.jet.math.tlong.LongPlusMultFirst
a + b*constant.
plusMult(long) - Static method in class cern.jet.math.tlong.LongPlusMultSecond
a + b*constant.
plusMultFirst(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
plusMultFirst(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a * constant + b.
plusMultFirst(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
plusMultFirst(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a * constant + b.
plusMultFirst(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a * constant + b.
plusMultFirst(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a * constant + b.
plusMultSecond(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
plusMultSecond(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a + b*constant.
plusMultSecond(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
plusMultSecond(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a + b*constant.
plusMultSecond(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a + b*constant.
plusMultSecond(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a + b*constant.
plusOne() - Static method in class flanagan.analysis.ErrorProp
 
PND - Class in jhplot
/** A container to hold data points in many dimensions.
PND(String) - Constructor for class jhplot.PND
Construct an empty container with a title
PND(String, boolean, PND) - Constructor for class jhplot.PND
Construct a copy from a PND.
PND(String, String) - Constructor for class jhplot.PND
Construct a container with a title from external file (see the method toFile() how to write such ASCII file).
PND() - Constructor for class jhplot.PND
Construct an empty container with no title
PNI - Class in jhplot
/** A container to hold data points in many dimensions.
PNI(String) - Constructor for class jhplot.PNI
Construct an empty container with a title
PNI(String, boolean, PNI) - Constructor for class jhplot.PNI
Construct a copy from a PNI.
PNI(String, String) - Constructor for class jhplot.PNI
Construct a container with a title from external file (see the method toFile() how to write such ASCII file)
PNI() - Constructor for class jhplot.PNI
Construct an empty container with no title
point(int) - Method in class hep.aida.ref.histogram.DataPointSet
 
PointSet - Class in umontreal.iro.lecuyer.hups
This abstract class defines the basic methods for accessing and manipulating point sets.
PointSet() - Constructor for class umontreal.iro.lecuyer.hups.PointSet
 
PointSetIterator - Interface in umontreal.iro.lecuyer.hups
Objects of classes that implement this interface are iterators that permit one to enumerate (or observe) the successive points of a point set and the successive coordinates of these points.
PointSetRandomization - Interface in umontreal.iro.lecuyer.hups
This interface is used to randomize a PointSet.
Poisson - Class in cern.jet.random
Poisson distribution (quick); See the math definition and animated definition.
Poisson(double, RandomEngine) - Constructor for class cern.jet.random.Poisson
Constructs a poisson distribution.
Poisson - Class in cern.jet.random.tdouble
Poisson distribution (quick); See the math definition and animated definition.
Poisson(double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.Poisson
Constructs a poisson distribution.
poisson(int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the first k terms of the Poisson distribution.
poisson(int, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the sum of the first k terms of the Poisson distribution.
poisson() - Method in class flanagan.analysis.Regression
 
poisson(int, double) - Static method in class flanagan.analysis.Stat
 
Poisson - Class in jhplot.fit
Poisson distribution.
Poisson() - Constructor for class jhplot.fit.Poisson
 
Poisson(String) - Constructor for class jhplot.fit.Poisson
 
Poisson(String[], String[]) - Constructor for class jhplot.fit.Poisson
 
Poisson - Class in jhplot.math.num.pdf
The Poisson distribution.
Poisson() - Constructor for class jhplot.math.num.pdf.Poisson
Default distribution.
Poisson(double) - Constructor for class jhplot.math.num.pdf.Poisson
Create a distribution with the given mean.
Poisson - Class in jhplot.math
Build a Poisson distribution
Poisson(Random, double) - Constructor for class jhplot.math.Poisson
Build a Posson generator
Poisson(double) - Constructor for class jhplot.math.Poisson
Build a Poisson random numbers with a given lambda
Poisson(long, double) - Constructor for class jhplot.math.Poisson
Build a Posson random numbers
PoissonBinError - Class in hep.aida.ref.dataset.binner
This class calculates the error on the bin assuming a Poisson distribution.
PoissonBinError() - Constructor for class hep.aida.ref.dataset.binner.PoissonBinError
 
poissonCDF(int, double) - Static method in class flanagan.analysis.Stat
 
poissonComplemented(int, double) - Static method in class cern.jet.stat.Probability
Returns the sum of the terms k+1 to Infinity of the Poisson distribution.
poissonComplemented(int, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the sum of the terms k+1 to Infinity of the Poisson distribution.
PoissonDist - Class in umontreal.iro.lecuyer.probdist
Extends the class DiscreteDistributionInt for the Poisson distribution with mean λ >=  0.
PoissonDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.PoissonDist
Creates an object that contains the probability and distribution functions, for the Poisson distribution with parameter lambda, which are computed and stored in dynamic arrays inside that object.
PoissonDistribution - Interface in org.apache.commons.math.distribution
Interface representing the Poisson Distribution.
PoissonDistributionImpl - Class in org.apache.commons.math.distribution
Implementation for the PoissonDistribution.
PoissonDistributionImpl(double) - Constructor for class org.apache.commons.math.distribution.PoissonDistributionImpl
Create a new Poisson distribution with the given the mean.
PoissonDistributionImpl(double, double, int) - Constructor for class org.apache.commons.math.distribution.PoissonDistributionImpl
Create a new Poisson distribution with the given mean, convergence criterion and maximum number of iterations.
PoissonDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.PoissonDistributionImpl
Create a new Poisson distribution with the given mean and convergence criterion.
PoissonDistributionImpl(double, int) - Constructor for class org.apache.commons.math.distribution.PoissonDistributionImpl
Create a new Poisson distribution with the given mean and maximum number of iterations.
PoissonDistributionImpl(double, NormalDistribution) - Constructor for class org.apache.commons.math.distribution.PoissonDistributionImpl
Deprecated. as of 2.1 (to avoid possibly inconsistent state, the "NormalDistribution" will be instantiated internally)
PoissonGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators having the Poisson distribution.
PoissonGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.PoissonGen
Creates a Poisson random variate generator with parameter λ = lambda, using stream s.
PoissonGen(RandomStream, PoissonDist) - Constructor for class umontreal.iro.lecuyer.randvar.PoissonGen
Creates a new random variate generator using the Poisson distribution dist and stream s.
poissonianArray(double, int) - Method in class flanagan.math.PsRandom
 
poissonPDF(int, double) - Static method in class flanagan.analysis.Stat
 
poissonPlot() - Method in class flanagan.analysis.Regression
 
poissonProb(int, double) - Static method in class flanagan.analysis.Stat
 
poissonRand(double, int) - Static method in class flanagan.analysis.Stat
 
poissonRand(double, int, long) - Static method in class flanagan.analysis.Stat
 
PoissonRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Poisson distribution.
PoissonRandomVariable() - Constructor for class jhplot.math.num.random.PoissonRandomVariable
Default constructor.
PoissonRandomVariable(double) - Constructor for class jhplot.math.num.random.PoissonRandomVariable
Create a random variable with the given mean.
PoissonRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.PoissonRandomVariable
Create a random variable with the given parameters.
PoissonSlow - Class in cern.jet.random
Poisson distribution; See the math definition and animated definition.
PoissonSlow(double, RandomEngine) - Constructor for class cern.jet.random.PoissonSlow
Constructs a poisson distribution.
PoissonSlow - Class in cern.jet.random.tdouble
Poisson distribution; See the math definition and animated definition.
PoissonSlow(double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.PoissonSlow
Constructs a poisson distribution.
PoissonTIACGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators having the Poisson distribution (see PoissonGen).
PoissonTIACGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.PoissonTIACGen
Creates a Poisson random variate generator with parameter λ = lambda, using stream s.
PoissonTIACGen(RandomStream, PoissonDist) - Constructor for class umontreal.iro.lecuyer.randvar.PoissonTIACGen
Creates a new random variate generator using the Poisson distribution dist and stream s.
polar2Complex(double, double) - Static method in class org.apache.commons.math.complex.ComplexUtils
Creates a complex number from the given polar representation.
polevl(double, double[], int) - Static method in class cern.jet.math.Polynomial
Evaluates the given polynomial of degree N at x.
polevl(double, double[], int) - Static method in class cern.jet.math.tdouble.Polynomial
Evaluates the given polynomial of degree N at x.
PolInterp - Class in umontreal.iro.lecuyer.functionfit
Represents a polynomial that interpolates through a set of points.
PolInterp(double[], double[]) - Constructor for class umontreal.iro.lecuyer.functionfit.PolInterp
Constructs a new polynomial interpolating through the given points (x[0], y[0]), ..., (x[n], y[n]).
PolyCubicSpline - Class in flanagan.interpolation
 
PolyCubicSpline(Object, Object) - Constructor for class flanagan.interpolation.PolyCubicSpline
 
PolyCubicSplineFast - Class in flanagan.interpolation
 
PolyCubicSplineFast(Object, Object) - Constructor for class flanagan.interpolation.PolyCubicSplineFast
 
POLYGON - Static variable in class jhplot.shapes.HShape
 
Polynomial - Class in cern.jet.math
Polynomial functions.
Polynomial - Class in cern.jet.math.tdouble
Polynomial functions.
polynomial(int) - Method in class flanagan.analysis.Regression
 
Polynomial - Class in umontreal.iro.lecuyer.functions
Represents a polynomial of degree n in power form.
Polynomial(double...) - Constructor for class umontreal.iro.lecuyer.functions.Polynomial
Constructs a new polynomial with coefficients coeff.
polynomialBest(int) - Method in class flanagan.analysis.Regression
 
PolynomialCoreNorm - Class in hep.aida.ref.function
Normalised Polynomial (Pn) distribution in the form: f = (1 + p1*x + p2*x*x + ...
PolynomialCoreNorm(String) - Constructor for class hep.aida.ref.function.PolynomialCoreNorm
 
PolynomialCoreNorm(String, double[]) - Constructor for class hep.aida.ref.function.PolynomialCoreNorm
 
PolynomialCoreNotNorm - Class in hep.aida.ref.function
Not normalised Polynomial (Pn) distribution in the form: f = p0 + p1*x + p2*x*x + ...
PolynomialCoreNotNorm(int, int) - Constructor for class hep.aida.ref.function.PolynomialCoreNotNorm
 
PolynomialCoreNotNorm(int, int, double[]) - Constructor for class hep.aida.ref.function.PolynomialCoreNotNorm
 
PolynomialCoreNotNorm(String) - Constructor for class hep.aida.ref.function.PolynomialCoreNotNorm
 
PolynomialCoreNotNorm(String, double[]) - Constructor for class hep.aida.ref.function.PolynomialCoreNotNorm
 
polynomialDerivative() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Returns the derivative as a PolynomialRealFunction
PolynomialFitter - Class in org.apache.commons.math.optimization.fitting
This class implements a curve fitting specialized for polynomials.
PolynomialFitter(int, DifferentiableMultivariateVectorialOptimizer) - Constructor for class org.apache.commons.math.optimization.fitting.PolynomialFitter
Simple constructor.
PolynomialFunction - Class in org.apache.commons.math.analysis.polynomials
Immutable representation of a real polynomial function with real coefficients.
PolynomialFunction(double[]) - Constructor for class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Construct a polynomial with the given coefficients.
PolynomialFunctionLagrangeForm - Class in org.apache.commons.math.analysis.polynomials
Implements the representation of a real polynomial function in Lagrange Form.
PolynomialFunctionLagrangeForm(double[], double[]) - Constructor for class org.apache.commons.math.analysis.polynomials.PolynomialFunctionLagrangeForm
Construct a Lagrange polynomial with the given abscissas and function values.
PolynomialFunctionNewtonForm - Class in org.apache.commons.math.analysis.polynomials
Implements the representation of a real polynomial function in Newton Form.
PolynomialFunctionNewtonForm(double[], double[]) - Constructor for class org.apache.commons.math.analysis.polynomials.PolynomialFunctionNewtonForm
Construct a Newton polynomial with the given a[] and c[].
PolynomialModelFunction - Class in hep.aida.ref.function
 
PolynomialModelFunction(String) - Constructor for class hep.aida.ref.function.PolynomialModelFunction
 
polynomialPlot(int, String, String) - Method in class flanagan.analysis.Regression
 
polynomialPlot(int) - Method in class flanagan.analysis.Regression
 
polynomialSplineDerivative() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialSplineFunction
Returns the derivative of the polynomial spline function as a PolynomialSplineFunction
PolynomialSplineFunction - Class in org.apache.commons.math.analysis.polynomials
Represents a polynomial spline function.
PolynomialSplineFunction(double[], PolynomialFunction[]) - Constructor for class org.apache.commons.math.analysis.polynomials.PolynomialSplineFunction
Construct a polynomial spline function with the given segment delimiters and interpolating polynomials.
PolynomialsUtils - Class in org.apache.commons.math.analysis.polynomials
A collection of static methods that operate on or return polynomials.
pooledMean(int, double, int, double) - Static method in class cern.jet.stat.Descriptive
Returns the pooled mean of two data sequences.
pooledMean(int, double, int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the pooled mean of two data sequences.
pooledMean(int, float, int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the pooled mean of two data sequences.
pooledVariance(int, double, int, double) - Static method in class cern.jet.stat.Descriptive
Returns the pooled variance of two data sequences.
pooledVariance(int, double, int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the pooled variance of two data sequences.
pooledVariance(int, float, int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the pooled variance of two data sequences.
Population - Interface in org.apache.commons.math.genetics
A collection of chromosomes that facilitates generational evolution.
Position - Class in jhplot.v3d
 
Position() - Constructor for class jhplot.v3d.Position
 
Position(Position) - Constructor for class jhplot.v3d.Position
 
POSITIVE_INFINITY - Static variable in class org.apache.commons.math.geometry.Vector3D
A vector with all coordinates set to positive infinity.
postCompose(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.ComposableFunction
Postcompose the instance with another function.
potentialRoundingError(double) - Static method in class flanagan.interpolation.BiCubicSpline
 
potentialRoundingError(double) - Static method in class flanagan.interpolation.BiCubicSplineFirstDerivative
 
potentialRoundingError(double) - Static method in class flanagan.interpolation.BiCubicSplinePartialDerivative
 
potentialRoundingError(double) - Static method in class flanagan.interpolation.CubicSpline
 
potentialRoundingError(double) - Static method in class flanagan.interpolation.PolyCubicSpline
 
potentialRoundingError(double) - Static method in class flanagan.interpolation.QuadriCubicSpline
 
potentialRoundingError(double) - Static method in class flanagan.interpolation.TriCubicSpline
 
poundToKg(double) - Static method in class flanagan.math.Conv
 
poundToKg(double) - Static method in class flanagan.math.Fmath
 
pow(DoubleMatrix1D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = As <=> A[i] = Math.pow(A[i], s).
pow(DoubleMatrix1D, DoubleMatrix1D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = AB <=> A[i] = Math.pow(A[i], B[i]).
pow(DoubleMatrix2D, double) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = As <=> A[row,col] = Math.pow(A[row,col], s).
pow(DoubleMatrix2D, DoubleMatrix2D) - Static method in class cern.colt.matrix.doublealgo.Transform
Deprecated. A = AB <=> A[row,col] = Math.pow(A[row,col], B[row,col]).
pow(DoubleMatrix2D, int) - Method in class cern.colt.matrix.linalg.Algebra
Linear algebraic matrix power; B = Ak <==> B = A*A*...*A.
pow(DoubleMatrix2D, int) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Linear algebraic matrix power; B = Ak <==> B = A*A*...*A.
pow(FloatMatrix2D, int) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Linear algebraic matrix power; B = Ak <==> B = A*A*...*A.
pow - Static variable in class cern.jet.math.Functions
Function that returns Math.pow(a,b).
pow(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns Math.pow(a,b).
pow - Static variable in class cern.jet.math.IntFunctions
Function that returns (int) Math.pow(a,b).
pow(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns (int) Math.pow(a,b).
pow(double[], double) - Static method in class cern.jet.math.tdcomplex.DComplex
 
pow(double, double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
pow(double[], double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
pow - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.pow(a,b).
pow(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns Math.pow(a,b).
pow(float[], float) - Static method in class cern.jet.math.tfcomplex.FComplex
 
pow(float, float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
pow(float[], float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
pow - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.pow(a,b).
pow(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns Math.pow(a,b).
pow - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns (int) Math.pow(a,b).
pow(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns (int) Math.pow(a,b).
pow - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns (long) Math.pow(a,b).
pow(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns (long) Math.pow(a,b).
pow(ErrorProp, double) - Static method in class flanagan.analysis.ErrorProp
 
pow(double, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
pow(ErrorProp, ErrorProp, double) - Static method in class flanagan.analysis.ErrorProp
 
pow(ErrorProp, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
pow(double) - Method in class flanagan.analysis.Stat
 
pow(float) - Method in class flanagan.analysis.Stat
 
pow(long) - Method in class flanagan.analysis.Stat
 
pow(int) - Method in class flanagan.analysis.Stat
 
pow(short) - Method in class flanagan.analysis.Stat
 
pow(byte) - Method in class flanagan.analysis.Stat
 
pow(Double) - Method in class flanagan.analysis.Stat
 
pow(Float) - Method in class flanagan.analysis.Stat
 
pow(Long) - Method in class flanagan.analysis.Stat
 
pow(Integer) - Method in class flanagan.analysis.Stat
 
pow(Short) - Method in class flanagan.analysis.Stat
 
pow(Byte) - Method in class flanagan.analysis.Stat
 
pow(BigInteger) - Method in class flanagan.analysis.Stat
 
pow(BigDecimal) - Method in class flanagan.analysis.Stat
 
pow(int) - Method in class flanagan.math.ArrayMaths
 
pow(double) - Method in class flanagan.math.ArrayMaths
 
pow(float) - Method in class flanagan.math.ArrayMaths
 
pow(long) - Method in class flanagan.math.ArrayMaths
 
pow(short) - Method in class flanagan.math.ArrayMaths
 
pow(byte) - Method in class flanagan.math.ArrayMaths
 
pow(Number) - Method in class flanagan.math.ArrayMaths
 
Pow - Class in jhplot.fit
Power-law distribution.
Pow() - Constructor for class jhplot.fit.Pow
 
Pow(String) - Constructor for class jhplot.fit.Pow
 
Pow(String[], String[]) - Constructor for class jhplot.fit.Pow
 
pow(ValueErr, double) - Static method in class jhplot.math.ValueErr
returns an ValueErr number raised to an error free power
pow(double, ValueErr) - Static method in class jhplot.math.ValueErr
returns an error free number raised to an ValueErr power
pow(ValueErr, ValueErr, double) - Static method in class jhplot.math.ValueErr
returns a ValueErr number raised to a ValueErr power with correlation
pow(ValueErr, ValueErr) - Static method in class jhplot.math.ValueErr
ValueErr number raised to a ValueErr power with no correlation
POW - Static variable in class org.apache.commons.math.analysis.BinaryFunction
Deprecated. The FastMath.pow method wrapped as a BinaryFunction.
pow(Complex) - Method in class org.apache.commons.math.complex.Complex
Returns of value of this complex number raised to the power of x.
pow(Dfp, int) - Static method in class org.apache.commons.math.dfp.DfpMath
Raises base to the power a by successive squaring.
pow(Dfp, Dfp) - Static method in class org.apache.commons.math.dfp.DfpMath
Computes x to the y power.
pow(int) - Method in class org.apache.commons.math.fraction.BigFraction
Returns a integer whose value is (thisexponent), returning the result in reduced form.
pow(long) - Method in class org.apache.commons.math.fraction.BigFraction
Returns a BigFraction whose value is (thisexponent), returning the result in reduced form.
pow(BigInteger) - Method in class org.apache.commons.math.fraction.BigFraction
Returns a BigFraction whose value is (thisexponent), returning the result in reduced form.
pow(double) - Method in class org.apache.commons.math.fraction.BigFraction
Returns a double whose value is (thisexponent), returning the result in reduced form.
pow(double, double) - Static method in class org.apache.commons.math.util.FastMath
Power function.
pow(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Raise an int to an int power.
pow(int, long) - Static method in class org.apache.commons.math.util.MathUtils
Raise an int to a long power.
pow(long, int) - Static method in class org.apache.commons.math.util.MathUtils
Raise a long to an int power.
pow(long, long) - Static method in class org.apache.commons.math.util.MathUtils
Raise a long to a long power.
pow(BigInteger, int) - Static method in class org.apache.commons.math.util.MathUtils
Raise a BigInteger to an int power.
pow(BigInteger, long) - Static method in class org.apache.commons.math.util.MathUtils
Raise a BigInteger to a long power.
pow(BigInteger, BigInteger) - Static method in class org.apache.commons.math.util.MathUtils
Raise a BigInteger to a BigInteger power.
pow1 - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
pow1(double) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
pow1 - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
pow1(float) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
pow2 - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
pow2(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
pow2 - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
pow2(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
pow3 - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
pow3(double[]) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
pow3 - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
pow3(float[]) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
PowellOptimizer - Class in org.apache.commons.math.optimization.direct
Powell algorithm.
PowellOptimizer() - Constructor for class org.apache.commons.math.optimization.direct.PowellOptimizer
Constructor with default line search tolerances (see the other constructor).
PowellOptimizer(double) - Constructor for class org.apache.commons.math.optimization.direct.PowellOptimizer
Constructor with default absolute line search tolerances (see the other constructor).
PowellOptimizer(double, double) - Constructor for class org.apache.commons.math.optimization.direct.PowellOptimizer
 
power(long) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Raises the BitMatrix to the power p.
power10(int) - Method in class org.apache.commons.math.dfp.Dfp
Return the specified power of 10.
power10K(int) - Method in class org.apache.commons.math.dfp.Dfp
Get the specified power of 10000.
power2e(int) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Raises the BitMatrix to power 2e.
PowerDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the power distribution with shape parameter c > 0, over the interval [a, b], where a < b.
PowerDist(double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.PowerDist
Constructs a PowerDist object with parameters a = a, b = b and c = c.
PowerDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.PowerDist
Constructs a PowerDist object with parameters a = 0, b = b and c = c.
PowerDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.PowerDist
Constructs a PowerDist object with parameters a = 0, b = 1 and c = c.
PowerGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the power distribution with shape parameter c > 0, over the interval [a, b].
PowerGen(RandomStream, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.PowerGen
Creates a Power random variate generator with parameters a = a, b = b and c = c, using stream s.
PowerGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.PowerGen
Creates a Power random variate generator with parameters a = 0, b = 1 and c = c, using stream s.
PowerGen(RandomStream, PowerDist) - Constructor for class umontreal.iro.lecuyer.randvar.PowerGen
Creates a new generator for the power distribution dist and stream s.
PowerMathFunction - Class in umontreal.iro.lecuyer.functions
Represents a function computing (af (x) + b)p for a user-defined function f (x) and power p.
PowerMathFunction(MathFunction, double) - Constructor for class umontreal.iro.lecuyer.functions.PowerMathFunction
Constructs a new power function for function func and power power.
PowerMathFunction(MathFunction, double, double, double) - Constructor for class umontreal.iro.lecuyer.functions.PowerMathFunction
Constructs a new power function for function func, power power, and constants a and b.
powerRatios(DoubleArrayList) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Applies the power ratios transformation W.
PowerSeries - Class in jhplot.math.num
This class provides the means to evaluate infinite power series (1).
powerSpectrum() - Method in class flanagan.math.FourierTransform
 
powerSpectrum(String) - Method in class flanagan.math.FourierTransform
 
PowModified - Class in jhplot.fit
Power-law distribution with additional tail suppression.
PowModified() - Constructor for class jhplot.fit.PowModified
 
PowModified(String) - Constructor for class jhplot.fit.PowModified
 
PowModified(String[], String[]) - Constructor for class jhplot.fit.PowModified
 
prand(double) - Static method in class jhpro.stat.limit.LimitCalculatorGui
 
PReader - Class in jhplot.io
Some generic methods to read data and to return BufferedReader.
PReader() - Constructor for class jhplot.io.PReader
 
precondition(double[], double[]) - Method in interface org.apache.commons.math.optimization.general.Preconditioner
Precondition a search direction.
Preconditioner - Interface in org.apache.commons.math.optimization.general
This interface represents a preconditioner for differentiable scalar objective function optimizers.
predict(NeuralData) - Method in class jhplot.HNeuralNet
Evaluate data using currenr NN
predict(P0D) - Method in class jhplot.HNeuralNet
Generate prediction for input data
predict(BasicNeuralDataSet) - Method in class jhplot.HNeuralNet
Evaluate data set using currenr NN
predict(PND) - Method in class jhplot.HNeuralNet
Generate predictions for all input data
predict() - Method in class jhplot.HNeuralNet
Generate predictions for the data.
predict(double) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Returns the "predicted" y value associated with the supplied x value, based on the data that has been added to the model when this method is activated.
preferredSize() - Method in class jhplot.v3d.Canvas3d
 
prefix - Static variable in class hep.aida.ref.function.FunctionCatalog
 
PREFS_FILENAME - Static variable in class jhplot.HPlotJa
The file where user-selected preferences will be stored.
preMultiply(FieldMatrix<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the result premultiplying this by m.
preMultiply(T[]) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldVector<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealMatrix) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the result premultiplying this by m.
preMultiply(double[]) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealVector) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(T[]) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(BigMatrix) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the result premultiplying this by m.
preMultiply(BigDecimal[]) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(BigMatrix) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the result premultiplying this by m.
preMultiply(BigDecimal[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(T[]) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldMatrix<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the result premultiplying this by m.
preMultiply(T[]) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result premultiplying this by m.
preMultiply(double[]) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(RealVector) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the (row) vector result of premultiplying this by the vector v.
preMultiply(double[]) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Returns the (row) vector result of premultiplying this by the vector v.
presentation() - Method in class flanagan.math.TimeAndDate
 
presentation(int) - Method in class flanagan.math.TimeAndDate
 
PrimeFinder - Class in cern.colt.map
Not of interest for users; only for implementors of hashtables.
print(int) - Method in class cern.jet.random.engine.RandomSeedGenerator
Prints the next size generated seeds.
print(int) - Method in class cern.jet.random.tdouble.engine.RandomSeedGenerator
Prints the next size generated seeds.
print(String) - Method in class flanagan.analysis.ErrorProp
 
print() - Method in class flanagan.analysis.ErrorProp
 
print(String, int) - Method in class flanagan.analysis.Regression
 
print(int) - Method in class flanagan.analysis.Regression
 
print(String) - Method in class flanagan.analysis.Regression
 
print() - Method in class flanagan.analysis.Regression
 
print() - Method in class flanagan.math.ArrayMaths
 
print(double[]) - Static method in class flanagan.math.Fmath
 
print(float[]) - Static method in class flanagan.math.Fmath
 
print(int[]) - Static method in class flanagan.math.Fmath
 
print(long[]) - Static method in class flanagan.math.Fmath
 
print(char[]) - Static method in class flanagan.math.Fmath
 
print(String[]) - Static method in class flanagan.math.Fmath
 
print(short[]) - Static method in class flanagan.math.Fmath
 
print(byte[]) - Static method in class flanagan.math.Fmath
 
print(double[][]) - Static method in class flanagan.math.Fmath
 
print(String, int) - Method in class flanagan.math.Maximisation
 
print(int) - Method in class flanagan.math.Maximisation
 
print(String) - Method in class flanagan.math.Maximisation
 
print() - Method in class flanagan.math.Maximisation
 
print(String, int) - Method in class flanagan.math.Minimisation
 
print(int) - Method in class flanagan.math.Minimisation
 
print(String) - Method in class flanagan.math.Minimisation
 
print() - Method in class flanagan.math.Minimisation
 
print() - Method in class hephysics.particle.HEParticle
Print particle
print() - Method in class hephysics.particle.LParticle
Print particle
print() - Method in class jhplot.H1D
Print histogram on screen
print() - Method in class jhplot.HProf1D
Print histogram on screen
print() - Method in class jhplot.jadraw.JaKey
 
print() - Method in class jhplot.jadraw.JaText
 
print(double[]) - Static method in class jhplot.math.ArrayMathUtils
Prints an array to screen.
print(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Prints an array to screen.
print(int[]) - Static method in class jhplot.math.ArrayMathUtils
Prints an array to screen.
print(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Prints an array to screen.
print() - Method in class jhplot.P0D
Print a P0D container.
print() - Method in class jhplot.P0I
Print a P0I container.
print() - Method in class jhplot.P1D
Print a P1D container on the screen
print() - Method in class jhplot.P2D
Print a P2D container on the screen
print() - Method in class jhplot.P3D
Print a P3D container on the screen
print() - Method in class jhplot.PND
Print PND to System.out.
print() - Method in class jhplot.PNI
Print PNI to System.out.
print() - Method in class jhplot.v3d.Vector3d
 
print() - Method in class jminhep.cluster.DataHolder
Print all entries of the data holder
print(String) - Static method in class umontreal.iro.lecuyer.hups.F2wStructure
Prints the content of file filename.
printArray(float[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printArray(double[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printArray(float[], float[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printArray(double[], double[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printArray(int[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printArray(long[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints an array to the underlying stream.
printBinning() - Method in class hep.aida.ref.function.Grid
 
printComments(String[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints all the comments.
printCoordinate(int[], float[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], double[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], long[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], float[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], double[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], float[], float[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], double[], double[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], float[], float[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], double[], double[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], int[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], long[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], float[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], double[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], float[], float[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], double[], double[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], int[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[], long[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], float[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], double[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], float[], float[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], double[], double[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], int[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCoordinate(int[], long[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinate format to the underlying stream.
printCorrelation() - Method in class flanagan.math.FourierTransform
 
printCorrelation(String) - Method in class flanagan.math.FourierTransform
 
printData() - Method in class umontreal.iro.lecuyer.util.BitMatrix
Creates a String containing all the data of the BitMatrix.
printDoubleArray(double[][]) - Static method in class jhplot.math.io.ArrayString
 
printDoubleArray(double[]) - Static method in class jhplot.math.io.ArrayString
 
printDoubleArray(double[][], String, String) - Static method in class jhplot.math.io.ArrayString
 
printDrawOptions() - Method in class jhplot.DrawOptions
print all drawing options
printDrawOptions(PrintStream) - Method in class jhplot.DrawOptions
Get all drawing options as PrintStream
PrintfFormat - Class in umontreal.iro.lecuyer.util
This class acts like a StringBuffer which defines new types of append methods.
PrintfFormat() - Constructor for class umontreal.iro.lecuyer.util.PrintfFormat
Constructs a new buffer object containing an empty string.
PrintfFormat(int) - Constructor for class umontreal.iro.lecuyer.util.PrintfFormat
Constructs a new buffer object with an initial capacity of length.
PrintfFormat(String) - Constructor for class umontreal.iro.lecuyer.util.PrintfFormat
Constructs a new buffer object containing the initial string str.
printGeneratorMatrices(int) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Prints the generator matrices in standard form for dimensions 1 to s.
printGeneratorMatrices(int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
Prints the generator matrices as bit matrices in standard form for dimensions 1 to s.
printGeneratorMatricesTrans(int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
Prints the generator matrices transposed in the form of integers for dimensions 1 to s.
printGraph() - Method in class jhplot.GHPanel
Print the canvas
printGraphSettings() - Method in class jhplot.HPlot
Print the current graph settings to System.out
printGraphSettings(PrintStream) - Method in class jhplot.HPlot
Print the current graph settings to System.out
printIntArray(int[][]) - Static method in class jhplot.math.io.ArrayString
 
printIntArray(int[]) - Static method in class jhplot.math.io.ArrayString
 
printIntArray(int[][], String, String) - Static method in class jhplot.math.io.ArrayString
 
println(String) - Method in class flanagan.analysis.ErrorProp
 
println() - Method in class flanagan.analysis.ErrorProp
 
println() - Method in class flanagan.math.ArrayMaths
 
println(double[]) - Static method in class flanagan.math.Fmath
 
println(float[]) - Static method in class flanagan.math.Fmath
 
println(int[]) - Static method in class flanagan.math.Fmath
 
println(long[]) - Static method in class flanagan.math.Fmath
 
println(char[]) - Static method in class flanagan.math.Fmath
 
println(String[]) - Static method in class flanagan.math.Fmath
 
println(short[]) - Static method in class flanagan.math.Fmath
 
println(byte[]) - Static method in class flanagan.math.Fmath
 
printMatrixInfo(MatrixInfo) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the matrix info
printMatrixSize(MatrixSize, MatrixInfo) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the matrix size
printMatrixSize(MatrixSize) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the matrix size.
printPattern(int[], int[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinates to the underlying stream.
printPattern(int[], int) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinates to the underlying stream.
printPattern(int[], int[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinates to the underlying stream.
printPattern(int[]) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the coordinates to the underlying stream.
printPowerSpectrum() - Method in class flanagan.math.FourierTransform
 
printPowerSpectrum(String) - Method in class flanagan.math.FourierTransform
 
printResult() - Method in class hep.aida.ref.fitter.FitResult
 
printShortTime() - Method in class flanagan.math.FourierTransform
 
printShortTime(String) - Method in class flanagan.math.FourierTransform
 
printStackTrace() - Method in exception org.apache.commons.math.MathException
Prints the stack trace of this exception to the standard error stream.
printStackTrace(PrintStream) - Method in exception org.apache.commons.math.MathException
Prints the stack trace of this exception to the specified stream.
printStackTrace() - Method in exception org.apache.commons.math.MathRuntimeException
Prints the stack trace of this exception to the standard error stream.
printStackTrace(PrintStream) - Method in exception org.apache.commons.math.MathRuntimeException
Prints the stack trace of this exception to the specified stream.
printVectorInfo(VectorInfo) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the vector info
printVectorSize(VectorSize, VectorInfo) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the vector size
printVectorSize(VectorSize) - Method in class cern.colt.matrix.io.MatrixVectorWriter
Prints the vector size.
printVersion() - Static method in class jhplot.JHPlot
jHplot version information
priority() - Method in class umontreal.iro.lecuyer.simevents.Event
Returns the priority of this event.
priority() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Returns the priority of the current variable.
Prism - Class in jhplot.v3d
Build a prism.
Prism(Model3d, Vector3d[], int, Vector3d) - Constructor for class jhplot.v3d.Prism
 
prob(int) - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
 
prob(double, int) - Static method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Returns the Bernoulli probability f (x) with parameter p (see eq.).
prob(int) - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
 
prob(int, double, int) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
Computes and returns the binomial probability p(x) in eq..
prob(int, double, double, int) - Static method in class umontreal.iro.lecuyer.probdist.BinomialDist
A generalization of the previous method.
prob(int) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
Returns pk, the probability of the k-th observation, for 0 <= k < n.
prob(int) - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistributionInt
Returns p(x), the probability of x, which should be a real number in the interval [0, 1].
prob(int) - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
 
prob(int) - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
 
prob(double, int) - Static method in class umontreal.iro.lecuyer.probdist.GeometricDist
Computes the geometric probability p(x).
prob(int) - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
 
prob(int, int, int, int) - Static method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Computes the hypergeometric probability p(x).
prob(int) - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
 
prob(double, int) - Static method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Computes the logarithmic probability p(x).
prob(int) - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
 
prob(double, double, int) - Static method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Computes the probability p(x).
prob(int) - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
 
prob(double, int) - Static method in class umontreal.iro.lecuyer.probdist.PoissonDist
Computes and returns the Poisson probability p(x) for λ = lambda..
prob(int) - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
 
prob(int, int, int) - Static method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Computes the discrete uniform probability p(x).
prob(int[]) - Method in class umontreal.iro.lecuyer.probdistmulti.DiscreteDistributionIntMulti
Returns the probability mass function p(x1, x2,…, xd), which should be a real number in [0, 1].
prob(int[]) - Method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
 
prob(int, double[], int[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Computes the probability mass function of the multinomial distribution with parameters n and (p1,...,pd) evaluated at x.
prob(int[]) - Method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
 
prob(double, double[], int[]) - Static method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Computes the probability mass function of the negative multinomial distribution with parameters γ and (p1,...,pd), evaluated at x.
Probability - Class in cern.jet.stat
Custom tailored numerical integration of certain probability distributions.
Probability - Class in cern.jet.stat.tdouble
Custom tailored numerical integration of certain probability distributions.
probability(int) - Method in class jhplot.math.num.pdf.Binomial
The PMF for this distribution.
probability(int) - Method in class jhplot.math.num.pdf.DiscreteDistribution
The PMF for this distribution.
probability(int) - Method in class jhplot.math.num.pdf.Geometric
The PMF for this distribution.
probability(int) - Method in class jhplot.math.num.pdf.Hypergeometric
The PMF for this distribution.
probability(int) - Method in class jhplot.math.num.pdf.NegativeBinomial
The PMF for this distribution.
probability(int) - Method in class jhplot.math.num.pdf.Poisson
The PMF for this distribution.
probability(double) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
For this distribution, X, this method returns P(X = x).
probability(double) - Method in interface org.apache.commons.math.distribution.DiscreteDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
For this distribution, X, this method returns P(X = x).
probability(int) - Method in interface org.apache.commons.math.distribution.IntegerDistribution
For a random variable X whose values are distributed according to this distribution, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
For this distribution, X, this method returns P(X = x).
probability(int) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
The probability mass function P(X = x) for a Poisson distribution.
probability(int) - Method in class org.apache.commons.math.distribution.ZipfDistributionImpl
The probability mass function P(X = x) for a Zipf distribution.
ProbabilityPlot - Class in flanagan.analysis
 
ProbabilityPlot(double[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(Double[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(float[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(Float[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(long[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(Long[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(int[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(Integer[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(short[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(Short[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(byte[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(Byte[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(BigDecimal[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(BigInteger[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(Object[]) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(Vector<Object>) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(ArrayList<Object>) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(ArrayMaths) - Constructor for class flanagan.analysis.ProbabilityPlot
 
ProbabilityPlot(Stat) - Constructor for class flanagan.analysis.ProbabilityPlot
 
probabilityValues() - Method in class flanagan.analysis.RankAnalysis
 
probAtn(double, int) - Static method in class flanagan.analysis.Stat
 
process(int) - Method in class jhplot.stat.StatShape
Process event.
process(int) - Method in class jhpro.stat.Moments
Process current event for an integer random variable
process(double) - Method in class jhpro.stat.Moments
Process current event for a double random variable
process(int) - Method in class jhpro.stat.MomentsFac
Process current event for an integer random variable
process(int) - Method in class jhpro.stat.MomentsFacNorm
Process current event for an integer random variable
process(int) - Method in class jhpro.stat.MomentsNorm
Process current event for an integer random variable
ProcessSimulator - Class in umontreal.iro.lecuyer.simprocs
Defines a special type of simulator capable of managing processes.
ProcessSimulator() - Constructor for class umontreal.iro.lecuyer.simprocs.ProcessSimulator
 
product() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the product, which is Prod( x[i] ).
product(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the product, which is Prod( data[i] ).
product(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the product of a data sequence, which is Prod( data[i] ).
product(int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the product, which is Prod( data[i] ).
product(DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the product of a data sequence, which is Prod( data[i] ) .
product(int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the product, which is Prod( data[i] ).
product(FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the product of a data sequence, which is Prod( data[i] ) .
product() - Method in class flanagan.math.ArrayMaths
 
product() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the product, which is Prod( x[i] ).
product() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the product, which is Prod( x[i] ).
product(double[]) - Static method in class jhplot.math.DoubleArray
Calculates the product of the values in an array.
product(double[][]) - Static method in class jhplot.math.DoubleArray
Calculates the product of the values in each column of a matrix.
Product - Class in org.apache.commons.math.stat.descriptive.summary
Returns the product of the available values.
Product() - Constructor for class org.apache.commons.math.stat.descriptive.summary.Product
Create a Product instance
Product(Product) - Constructor for class org.apache.commons.math.stat.descriptive.summary.Product
Copy constructor, creates a new Product identical to the original
product(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the product of the entries in the input array, or Double.NaN if the array is empty.
product(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the product of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
product_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
product_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
product_as_byte() - Method in class flanagan.math.ArrayMaths
 
product_as_Byte() - Method in class flanagan.math.ArrayMaths
 
product_as_Complex() - Method in class flanagan.math.ArrayMaths
 
product_as_double() - Method in class flanagan.math.ArrayMaths
 
product_as_Double() - Method in class flanagan.math.ArrayMaths
 
product_as_float() - Method in class flanagan.math.ArrayMaths
 
product_as_Float() - Method in class flanagan.math.ArrayMaths
 
product_as_int() - Method in class flanagan.math.ArrayMaths
 
product_as_Integer() - Method in class flanagan.math.ArrayMaths
 
product_as_long() - Method in class flanagan.math.ArrayMaths
 
product_as_Long() - Method in class flanagan.math.ArrayMaths
 
product_as_Phasor() - Method in class flanagan.math.ArrayMaths
 
product_as_short() - Method in class flanagan.math.ArrayMaths
 
product_as_Short() - Method in class flanagan.math.ArrayMaths
 
product_as_String() - Method in class flanagan.math.ArrayMaths
 
Profile - Class in hep.aida.ref.histogram
 
Profile(String, String, int) - Constructor for class hep.aida.ref.histogram.Profile
Create a new Profile
Profile(String, String, int, String) - Constructor for class hep.aida.ref.histogram.Profile
 
Profile1D - Class in hep.aida.ref.histogram
 
Profile1D() - Constructor for class hep.aida.ref.histogram.Profile1D
Create a 1-dimensional Profile.
Profile1D(String, String, IAxis) - Constructor for class hep.aida.ref.histogram.Profile1D
Create a 1-dimensional Profile.
Profile1D(String, String, IAxis, String) - Constructor for class hep.aida.ref.histogram.Profile1D
 
Profile2D - Class in hep.aida.ref.histogram
 
Profile2D() - Constructor for class hep.aida.ref.histogram.Profile2D
Create a 1-dimensional Profile.
Profile2D(String, String, IAxis, IAxis) - Constructor for class hep.aida.ref.histogram.Profile2D
Create a 1-dimensional Profile.
Profile2D(String, String, IAxis, IAxis, String) - Constructor for class hep.aida.ref.histogram.Profile2D
 
project(IHistogram1D, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram1D, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram1D, IEvaluator, IFilter, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram1D, IEvaluator, IFilter) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram2D, IEvaluator, IEvaluator, IFilter) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram2D, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram2D, IEvaluator, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram2D, IEvaluator, IEvaluator, IFilter, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram3D, IEvaluator, IEvaluator, IEvaluator, IFilter) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram3D, IEvaluator, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram3D, IEvaluator, IEvaluator, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IHistogram3D, IEvaluator, IEvaluator, IEvaluator, IFilter, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud1D, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud1D, IEvaluator, IFilter) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud1D, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud1D, IEvaluator, IFilter, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud2D, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud2D, IEvaluator, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud2D, IEvaluator, IEvaluator, IFilter) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud2D, IEvaluator, IEvaluator, IFilter, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud3D, IEvaluator, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud3D, IEvaluator, IEvaluator, IEvaluator, IFilter) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud3D, IEvaluator, IEvaluator, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(ICloud3D, IEvaluator, IEvaluator, IEvaluator, IFilter, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IProfile1D, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IProfile1D, IEvaluator, IEvaluator, IFilter) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IProfile1D, IEvaluator, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IProfile1D, IEvaluator, IEvaluator, IFilter, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IProfile2D, IEvaluator, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IProfile2D, IEvaluator, IEvaluator, IEvaluator, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IProfile2D, IEvaluator, IEvaluator, IEvaluator, IFilter) - Method in class hep.aida.ref.tuple.AbstractTuple
 
project(IProfile2D, IEvaluator, IEvaluator, IEvaluator, IFilter, IEvaluator) - Method in class hep.aida.ref.tuple.AbstractTuple
 
projection(double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Find the orthogonal projection of this vector onto another vector.
projection(FieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(T[]) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(ArrayFieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Find the orthogonal projection of this vector onto another vector.
projection(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Find the orthogonal projection of this vector onto another vector.
projection(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Find the orthogonal projection of this vector onto another vector.
projection(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldVector
Find the orthogonal projection of this vector onto another vector.
projection(T[]) - Method in interface org.apache.commons.math.linear.FieldVector
Find the orthogonal projection of this vector onto another vector.
projection(RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Find the orthogonal projection of this vector onto another vector.
projection(double[]) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Find the orthogonal projection of this vector onto another vector.
projection(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Find the orthogonal projection of this vector onto another vector.
projection(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Find the orthogonal projection of this vector onto another vector.
projection(FieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Find the orthogonal projection of this vector onto another vector.
projection(T[]) - Method in class org.apache.commons.math.linear.SparseFieldVector
Find the orthogonal projection of this vector onto another vector.
projectionX(String, IHistogram2D) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a projection from a 2D histogram parallel to the X axis.
projectionX() - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Create a projection parallel to the X axis.
projectionX() - Method in interface hep.aida.tfloat.FloatIHistogram2D
Create a projection parallel to the X axis.
projectionXY(String, IHistogram3D) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a projection parallel to the X axis from a 3D histogram.
projectionXY() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Create a projection parallel to the XY plane.
projectionXY() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Create a projection parallel to the XY plane.
projectionXZ(String, IHistogram3D) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a projection parallel to the Z axis from a 3D histogram.
projectionXZ() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Create a projection parallel to the XZ plane.
projectionXZ() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Create a projection parallel to the XZ plane.
projectionY(String, IHistogram2D) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a projection from a 2D histogram parallel to the Y axis.
projectionY() - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Create a projection parallel to the Y axis.
projectionY() - Method in interface hep.aida.tfloat.FloatIHistogram2D
Create a projection parallel to the Y axis.
projectionYZ(String, IHistogram3D) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a projection parallel to the Y axis from a 3D histogram.
projectionYZ() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Create a projection parallel to the YZ plane.
projectionYZ() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Create a projection parallel to the YZ plane.
ProperBigFractionFormat - Class in org.apache.commons.math.fraction
Formats a BigFraction number in proper format.
ProperBigFractionFormat() - Constructor for class org.apache.commons.math.fraction.ProperBigFractionFormat
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
ProperBigFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math.fraction.ProperBigFractionFormat
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
ProperBigFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math.fraction.ProperBigFractionFormat
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
ProperFractionFormat - Class in org.apache.commons.math.fraction
Formats a Fraction number in proper format.
ProperFractionFormat() - Constructor for class org.apache.commons.math.fraction.ProperFractionFormat
Create a proper formatting instance with the default number format for the whole, numerator, and denominator.
ProperFractionFormat(NumberFormat) - Constructor for class org.apache.commons.math.fraction.ProperFractionFormat
Create a proper formatting instance with a custom number format for the whole, numerator, and denominator.
ProperFractionFormat(NumberFormat, NumberFormat, NumberFormat) - Constructor for class org.apache.commons.math.fraction.ProperFractionFormat
Create a proper formatting instance with a custom number format for each of the whole, numerator, and denominator.
property() - Method in class cern.colt.matrix.linalg.Algebra
Returns the property object attached to this Algebra, defining tolerance.
Property - Class in cern.colt.matrix.linalg
Tests matrices for linear algebraic properties (equality, tridiagonality, symmetry, singularity, etc).
Property(double) - Constructor for class cern.colt.matrix.linalg.Property
Constructs an instance with a tolerance of Math.abs(newTolerance).
property() - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the property object attached to this Algebra, defining tolerance.
property() - Method in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Returns the property object attached to this Algebra, defining tolerance.
property() - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the property object attached to this Algebra, defining tolerance.
property() - Method in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Returns the property object attached to this Algebra, defining tolerance.
proportionPercentage() - Method in class flanagan.analysis.PCA
 
proton_mass_c2 - Static variable in class cern.clhep.PhysicalConstants
 
providesColumnDefaultValues() - Method in class hep.aida.ref.tuple.AbstractTuple
 
providesColumnDefaultValues() - Method in class hep.aida.ref.tuple.ChainedTuple
 
providesColumnDefaultValues() - Method in class hep.aida.ref.tuple.Tuple
 
providesGradient() - Method in class hep.aida.ref.fitter.InternalFitFunction
 
providesGradient() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
providesGradient() - Method in class hep.aida.ref.function.AbstractIFunction
 
providesGradient() - Method in class hep.aida.ref.function.BaseModelFunction
 
providesGradient() - Method in class hep.aida.ref.function.ExponentialCoreNorm
 
providesGradient() - Method in class hep.aida.ref.function.ExponentialCoreNotNorm
 
providesGradient() - Method in class hep.aida.ref.function.FunctionCore
 
providesGradient() - Method in class hep.aida.ref.function.GaussianCore2DNorm
 
providesGradient() - Method in class hep.aida.ref.function.GaussianCore2DNotNorm
 
providesGradient() - Method in class hep.aida.ref.function.GaussianCoreNorm
 
providesGradient() - Method in class hep.aida.ref.function.GaussianCoreNotNorm
 
providesGradient() - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
providesGradient() - Method in class hep.aida.ref.function.JELFunctionCore
 
providesGradient() - Method in class hep.aida.ref.function.LorentzianCoreNotNorm
 
providesGradient() - Method in class hep.aida.ref.function.MoyalCoreNotNorm
 
providesGradient() - Method in class hep.aida.ref.function.PolynomialCoreNotNorm
 
providesGradient() - Method in class hep.aida.ref.function.SumOfFunctions
 
providesNormalization() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
providesNormalization() - Method in class hep.aida.ref.function.AbstractIFunction
 
providesNormalization() - Method in class hep.aida.ref.function.BaseModelFunction
 
providesNormalization() - Method in class hep.aida.ref.function.ExponentialCoreNorm
 
providesNormalization() - Method in class hep.aida.ref.function.ExponentialCoreNotNorm
 
providesNormalization() - Method in class hep.aida.ref.function.FunctionCore
 
providesNormalization() - Method in class hep.aida.ref.function.GaussianCore2DNorm
 
providesNormalization() - Method in class hep.aida.ref.function.GaussianCore2DNotNorm
 
providesNormalization() - Method in class hep.aida.ref.function.GaussianCoreNorm
 
providesNormalization() - Method in class hep.aida.ref.function.GaussianCoreNotNorm
 
providesNormalization() - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
providesNormalization() - Method in class hep.aida.ref.function.JELFunctionCore
 
providesNormalization() - Method in class hep.aida.ref.function.LorentzianCoreNotNorm
 
providesNormalization() - Method in class hep.aida.ref.function.MoyalCoreNotNorm
 
providesNormalization() - Method in class hep.aida.ref.function.PolynomialCoreNotNorm
 
providesParameterGradient() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
providesParameterGradient() - Method in class hep.aida.ref.function.AbstractIFunction
 
providesParameterGradient() - Method in class hep.aida.ref.function.BaseModelFunction
 
providesParameterGradient() - Method in class hep.aida.ref.function.ExponentialCoreNorm
 
providesParameterGradient() - Method in class hep.aida.ref.function.ExponentialCoreNotNorm
 
providesParameterGradient() - Method in class hep.aida.ref.function.FunctionCore
 
providesParameterGradient() - Method in class hep.aida.ref.function.GaussianCore2DNorm
 
providesParameterGradient() - Method in class hep.aida.ref.function.GaussianCore2DNotNorm
 
providesParameterGradient() - Method in class hep.aida.ref.function.GaussianCoreNorm
 
providesParameterGradient() - Method in class hep.aida.ref.function.GaussianCoreNotNorm
 
providesParameterGradient() - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
providesParameterGradient() - Method in class hep.aida.ref.function.JELFunctionCore
 
providesParameterGradient() - Method in class hep.aida.ref.function.LorentzianCoreNotNorm
 
providesParameterGradient() - Method in class hep.aida.ref.function.MoyalCoreNotNorm
 
providesParameterGradient() - Method in class hep.aida.ref.function.PolynomialCoreNotNorm
 
pseudoRapidity() - Method in class hephysics.vec.Hep3Vector
Pseudorapidity.
pseudoRapidity() - Method in class hephysics.vec.HepLorentzVector
Pseudorapidity.
PsRandom - Class in flanagan.math
 
PsRandom() - Constructor for class flanagan.math.PsRandom
 
PsRandom(long) - Constructor for class flanagan.math.PsRandom
 
purification() - Method in class flanagan.math.TimeAndDate
 
purification(int) - Method in class flanagan.math.TimeAndDate
 
put(int, int, boolean) - Method in class cern.colt.bitvector.BitMatrix
Sets the bit at the specified coordinate to the state specified by value.
put(int, boolean) - Method in class cern.colt.bitvector.BitVector
Sets the bit with index bitIndex to the state specified by value.
put(long[], int, boolean) - Static method in class cern.colt.bitvector.QuickBitVector
Sets the bit with index bitIndex in the bitvector bits to the state specified by value.
put(double, int) - Method in class cern.colt.map.AbstractDoubleIntMap
Associates the given key with the given value.
put(int, double) - Method in class cern.colt.map.AbstractIntDoubleMap
Associates the given key with the given value.
put(int, int) - Method in class cern.colt.map.AbstractIntIntMap
Associates the given key with the given value.
put(int, Object) - Method in class cern.colt.map.AbstractIntObjectMap
Associates the given key with the given value.
put(long, Object) - Method in class cern.colt.map.AbstractLongObjectMap
Associates the given key with the given value.
put(double, int) - Method in class cern.colt.map.OpenDoubleIntHashMap
Associates the given key with the given value.
put(int, double) - Method in class cern.colt.map.OpenIntDoubleHashMap
Associates the given key with the given value.
put(int, int) - Method in class cern.colt.map.OpenIntIntHashMap
Associates the given key with the given value.
put(int, Object) - Method in class cern.colt.map.OpenIntObjectHashMap
Associates the given key with the given value.
put(long, Object) - Method in class cern.colt.map.OpenLongObjectHashMap
Associates the given key with the given value.
put(double, int) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Associates the given key with the given value.
put(double, long) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Associates the given key with the given value.
put(int, double) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Associates the given key with the given value.
put(long, double) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Associates the given key with the given value.
put(double, int) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Associates the given key with the given value.
put(double, long) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Associates the given key with the given value.
put(int, double) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Associates the given key with the given value.
put(long, double) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Associates the given key with the given value.
put(float, int) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Associates the given key with the given value.
put(float, long) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Associates the given key with the given value.
put(int, float) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Associates the given key with the given value.
put(long, float) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Associates the given key with the given value.
put(float, int) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Associates the given key with the given value.
put(float, long) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Associates the given key with the given value.
put(int, float) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Associates the given key with the given value.
put(long, float) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Associates the given key with the given value.
put(int, int) - Method in class cern.colt.map.tint.AbstractIntIntMap
Associates the given key with the given value.
put(int, int) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Associates the given key with the given value.
put(int, int) - Method in class cern.colt.map.tint.QuickOpenIntIntHashMap
Associates the given key with the given value.
put(int, long) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Associates the given key with the given value.
put(long, int) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Associates the given key with the given value.
put(long, long) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Associates the given key with the given value.
put(int, long) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Associates the given key with the given value.
put(long, int) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Associates the given key with the given value.
put(long, long) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Associates the given key with the given value.
put(int, Object) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Associates the given key with the given value.
put(long, Object) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Associates the given key with the given value.
put(int, Object) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Associates the given key with the given value.
put(long, Object) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Associates the given key with the given value.
put(int, int, boolean) - Method in class cern.colt.matrix.tbit.BitMatrix
Sets the bit at the specified coordinate to the state specified by value.
put(int, boolean) - Method in class cern.colt.matrix.tbit.BitVector
Sets the bit with index bitIndex to the state specified by value.
put(long[], int, boolean) - Static method in class cern.colt.matrix.tbit.QuickBitVector
Sets the bit with index bitIndex in the bitvector bits to the state specified by value.
put(int, double) - Method in class org.apache.commons.math.util.OpenIntToDoubleHashMap
Put a value associated with a key in the map.
put(int, T) - Method in class org.apache.commons.math.util.OpenIntToFieldHashMap
Put a value associated with a key in the map.
put(int) - Method in class umontreal.iro.lecuyer.simprocs.Bin
Adds n tokens to this bin.
putLongFromTo(long, int, int) - Method in class cern.colt.bitvector.BitVector
Sets bits of the receiver from index from to index to to the bits of value.
putLongFromTo(long[], long, int, int) - Static method in class cern.colt.bitvector.QuickBitVector
Sets bits of a bitvector from index from to index to to the bits of value.
putLongFromTo(long, int, int) - Method in class cern.colt.matrix.tbit.BitVector
Sets bits of the receiver from index from to index to to the bits of value.
putLongFromTo(long[], long, int, int) - Static method in class cern.colt.matrix.tbit.QuickBitVector
Sets bits of a bitvector from index from to index to to the bits of value.
putQuick(int, int, boolean) - Method in class cern.colt.bitvector.BitMatrix
Sets the bit at the specified coordinate to the state specified by value; WARNING: Does not check preconditions.
putQuick(int, boolean) - Method in class cern.colt.bitvector.BitVector
Sets the bit with index bitIndex to the state specified by value; WARNING: Does not check preconditions.
putQuick(int, int, boolean) - Method in class cern.colt.matrix.tbit.BitMatrix
Sets the bit at the specified coordinate to the state specified by value; WARNING: Does not check preconditions.
putQuick(int, boolean) - Method in class cern.colt.matrix.tbit.BitVector
Sets the bit with index bitIndex to the state specified by value; WARNING: Does not check preconditions.
putTransformer(Class<?>, NumberTransformer) - Method in class org.apache.commons.math.util.TransformerMap
Sets a Class to Transformer Mapping in the Map.
pValue(double, int) - Static method in class flanagan.analysis.Stat
 
pwd() - Method in class hep.aida.ref.tree.Tree
Get the path of the current working directory.
pwd() - Method in class jhplot.io.FileAida
Print the current directory
px() - Method in class hephysics.vec.HepLorentzVector
Get X position or (Px,Py,Pz)
py() - Method in class hephysics.vec.HepLorentzVector
Get Y position or Py
Pyramid - Class in jhplot.v3d
Build a Pyramid.
Pyramid(Model3d, Vector3d[], int, Vector3d) - Constructor for class jhplot.v3d.Pyramid
 
Pyramid(Model3d, Vector3d[], int, float) - Constructor for class jhplot.v3d.Pyramid
 
pz() - Method in class hephysics.vec.HepLorentzVector
Get Z position ot Pz

Q

q(double, int[], double, LimitCalculatorGui.ExperimentData) - Method in class jhpro.stat.limit.LimitCalculatorGui.myFrame
 
Q_ELECTRON - Static variable in class flanagan.math.Fmath
 
QNAN - Static variable in class org.apache.commons.math.dfp.Dfp
Indicator value for quiet NaN.
qr(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Constructs and returns the QR-decomposition of the given matrix.
qr(DoubleMatrix2D, int) - Method in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Constructs and returns the QR-decomposition of the given matrix.
qr(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Constructs and returns the QR-decomposition of the given matrix.
qr(FloatMatrix2D, int) - Method in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Constructs and returns the QR-decomposition of the given matrix.
QR(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
QRDecomposition - Class in cern.colt.matrix.linalg
For an m x n matrix A with m >= n, the QR decomposition is an m x n orthogonal matrix Q and an n x n upper triangular matrix R so that A = Q*R.
QRDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.linalg.QRDecomposition
Constructs and returns a new QR decomposition object; computed by Householder reflections; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
QRDecomposition - Class in jhplot.math
QR Decomposition.
QRDecomposition(double[][]) - Constructor for class jhplot.math.QRDecomposition
QR Decomposition, computed by Householder reflections.
QRDecomposition - Interface in org.apache.commons.math.linear
An interface to classes that implement an algorithm to calculate the QR-decomposition of a real matrix.
QRDecompositionImpl - Class in org.apache.commons.math.linear
Calculates the QR-decomposition of a matrix.
QRDecompositionImpl(RealMatrix) - Constructor for class org.apache.commons.math.linear.QRDecompositionImpl
Calculates the QR-decomposition of the given matrix.
QuadriCubicSpline - Class in flanagan.interpolation
 
QuadriCubicSpline(double[], double[], double[], double[], double[][][][]) - Constructor for class flanagan.interpolation.QuadriCubicSpline
 
quality() - Method in class hep.aida.ref.fitter.FitResult
 
quantile(double) - Static method in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.quantile(percentage).
quantile(double) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the exact phi-quantile; that is, the smallest contained element elem for which holds that phi percent of elements are less than elem.
quantile(double) - Method in class cern.hep.aida.bin.QuantileBin1D
Computes and returns the phi-quantile.
quantile(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the phi-quantile; that is, an element elem for which holds that phi percent of data elements are less than elem.
quantile(DoubleArrayList, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the phi-quantile; that is, an element elem for which holds that phi percent of data elements are less than elem.
quantile(FloatArrayList, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the phi-quantile; that is, an element elem for which holds that phi percent of data elements are less than elem.
quantile(double) - Static method in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.quantile(percentage).
quantile(double) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the exact phi-quantile; that is, the smallest contained element elem for which holds that phi percent of elements are less than elem.
quantile(double) - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Computes and returns the phi-quantile.
quantile(float) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the exact phi-quantile; that is, the smallest contained element elem for which holds that phi percent of elements are less than elem.
quantile(float) - Static method in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.quantile(percentage).
quantile(float) - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Computes and returns the phi-quantile.
Quantile1Test - Class in cern.jet.stat.quantile
A class to test the QuantileBin1D code.
Quantile1Test() - Constructor for class cern.jet.stat.quantile.Quantile1Test
 
QuantileBin1D - Class in cern.hep.aida.bin
1-dimensional non-rebinnable bin holding double elements with scalable quantile operations defined upon; Using little main memory, quickly computes approximate quantiles over very large data sequences with and even without a-priori knowledge of the number of elements to be filled; Conceptually a strongly lossily compressed multiset (or bag); Guarantees to respect the worst case approximation error specified upon instance construction.
QuantileBin1D(double) - Constructor for class cern.hep.aida.bin.QuantileBin1D
Equivalent to new QuantileBin1D(false, Long.MAX_VALUE, epsilon, 0.001, 10000, new cern.jet.random.engine.DRand(new java.util.Date()).
QuantileBin1D(boolean, long, double, double, int, RandomEngine) - Constructor for class cern.hep.aida.bin.QuantileBin1D
Equivalent to new QuantileBin1D(known_N, N, epsilon, delta, quantiles, randomGenerator, false, false, 2).
QuantileBin1D(boolean, long, double, double, int, RandomEngine, boolean, boolean, int) - Constructor for class cern.hep.aida.bin.QuantileBin1D
Constructs and returns an empty bin that, under the given constraints, minimizes the amount of memory needed.
QuantileDoubleBin1D - Class in hep.aida.tdouble.bin
1-dimensional non-rebinnable bin holding double elements with scalable quantile operations defined upon; Using little main memory, quickly computes approximate quantiles over very large data sequences with and even without a-priori knowledge of the number of elements to be filled; Conceptually a strongly lossily compressed multiset (or bag); Guarantees to respect the worst case approximation error specified upon instance construction.
QuantileDoubleBin1D(double) - Constructor for class hep.aida.tdouble.bin.QuantileDoubleBin1D
Equivalent to new QuantileBin1D(false, Long.MAX_VALUE, epsilon, 0.001, 10000, new cern.jet.random.engine.DRand(new java.util.Date()) .
QuantileDoubleBin1D(boolean, long, double, double, int, DoubleRandomEngine) - Constructor for class hep.aida.tdouble.bin.QuantileDoubleBin1D
Equivalent to new QuantileBin1D(known_N, N, epsilon, delta, quantiles, randomGenerator, false, false, 2) .
QuantileDoubleBin1D(boolean, long, double, double, int, DoubleRandomEngine, boolean, boolean, int) - Constructor for class hep.aida.tdouble.bin.QuantileDoubleBin1D
Constructs and returns an empty bin that, under the given constraints, minimizes the amount of memory needed.
quantileElements(DoubleArrayList) - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Computes the specified quantile elements over the values previously added.
quantileElements(DoubleArrayList) - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Computes the specified quantile elements over the values previously added.
quantileElements(DoubleArrayList) - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Computes the specified quantile elements over the values previously added.
quantileElements(FloatArrayList) - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Computes the specified quantile elements over the values previously added.
QuantileFinderFactory - Class in cern.jet.stat.quantile
Factory constructing exact and approximate quantile finders for both known and unknown N.
QuantileFloatBin1D - Class in hep.aida.tfloat.bin
1-dimensional non-rebinnable bin holding float elements with scalable quantile operations defined upon; Using little main memory, quickly computes approximate quantiles over very large data sequences with and even without a-priori knowledge of the number of elements to be filled; Conceptually a strongly lossily compressed multiset (or bag); Guarantees to respect the worst case approximation error specified upon instance construction.
QuantileFloatBin1D(float) - Constructor for class hep.aida.tfloat.bin.QuantileFloatBin1D
Equivalent to new QuantileBin1D(false, Long.MAX_VALUE, epsilon, 0.001, 10000, new cern.jet.random.engine.DRand(new java.util.Date()) .
QuantileFloatBin1D(boolean, long, float, float, int, FloatRandomEngine) - Constructor for class hep.aida.tfloat.bin.QuantileFloatBin1D
Equivalent to new QuantileBin1D(known_N, N, epsilon, delta, quantiles, randomGenerator, false, false, 2) .
QuantileFloatBin1D(boolean, long, float, float, int, FloatRandomEngine, boolean, boolean, int) - Constructor for class hep.aida.tfloat.bin.QuantileFloatBin1D
Constructs and returns an empty bin that, under the given constraints, minimizes the amount of memory needed.
quantileInverse(double) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns exactly how many percent of the elements contained in the receiver are <= element.
quantileInverse(double) - Method in class cern.hep.aida.bin.QuantileBin1D
Returns how many percent of the elements contained in the receiver are <= element.
quantileInverse(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns how many percent of the elements contained in the receiver are <= element.
quantileInverse(DoubleArrayList, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns how many percent of the elements contained in the receiver are <= element.
quantileInverse(FloatArrayList, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns how many percent of the elements contained in the receiver are <= element.
quantileInverse(double) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns exactly how many percent of the elements contained in the receiver are <= element.
quantileInverse(double) - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Returns how many percent of the elements contained in the receiver are <= element.
quantileInverse(float) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns exactly how many percent of the elements contained in the receiver are <= element.
quantileInverse(float) - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Returns how many percent of the elements contained in the receiver are <= element.
quantiles(DoubleArrayList) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the exact quantiles of the specified percentages.
quantiles(DoubleArrayList) - Method in class cern.hep.aida.bin.QuantileBin1D
Returns the quantiles of the specified percentages.
quantiles(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the quantiles of the specified percentages.
quantiles(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the quantiles of the specified percentages.
quantiles(FloatArrayList, FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the quantiles of the specified percentages.
quantiles(DoubleArrayList) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the exact quantiles of the specified percentages.
quantiles(DoubleArrayList) - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Returns the quantiles of the specified percentages.
quantiles(FloatArrayList) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the exact quantiles of the specified percentages.
quantiles(FloatArrayList) - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Returns the quantiles of the specified percentages.
quartileSkewness() - Method in class flanagan.analysis.Stat
 
quartileSkewness(double[]) - Static method in class flanagan.analysis.Stat
 
quartileSkewness(float[]) - Static method in class flanagan.analysis.Stat
 
quartileSkewness(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
quartileSkewness(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
quartileSkewness(long[]) - Static method in class flanagan.analysis.Stat
 
quartileSkewness(int[]) - Static method in class flanagan.analysis.Stat
 
quartileSkewness_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
quartileSkewness_as_double() - Method in class flanagan.analysis.Stat
 
quartToLitre(double) - Static method in class flanagan.math.Conv
 
quartToLitre(double) - Static method in class flanagan.math.Fmath
 
quartUKtoUS(double) - Static method in class flanagan.math.Conv
 
quartUKtoUS(double) - Static method in class flanagan.math.Fmath
 
quartUStoUK(double) - Static method in class flanagan.math.Conv
 
quartUStoUK(double) - Static method in class flanagan.math.Fmath
 
QuickBitVector - Class in cern.colt.bitvector
Implements quick non polymorphic non bounds checking low level bitvector operations.
QuickBitVector - Class in cern.colt.matrix.tbit
Implements quick non polymorphic non bounds checking low level bitvector operations.
QuickOpenIntIntHashMap - Class in cern.colt.map.tint
Status: Experimental; Do not use for production yet.
QuickOpenIntIntHashMap() - Constructor for class cern.colt.map.tint.QuickOpenIntIntHashMap
Constructs an empty map with default capacity and default load factors.
QuickOpenIntIntHashMap(int) - Constructor for class cern.colt.map.tint.QuickOpenIntIntHashMap
Constructs an empty map with the specified initial capacity and default load factors.
QuickOpenIntIntHashMap(int, double, double) - Constructor for class cern.colt.map.tint.QuickOpenIntIntHashMap
Constructs an empty map with the specified initial capacity and the specified minimum and maximum load factor.
quickSelect(double[], int, int) - Static method in class umontreal.iro.lecuyer.util.Misc
Returns the kth smallest item of the array t of size n.
quickSelect(int[], int, int) - Static method in class umontreal.iro.lecuyer.util.Misc
Returns the kth smallest item of the array t of size n.
quickSort(int, int, IntComparator, Swapper) - Static method in class cern.colt.GenericSorting
Sorts the specified range of elements according to the order induced by the specified comparator.
quickSort() - Method in class cern.colt.list.AbstractList
Sorts the receiver into ascending order.
quickSort - Static variable in class cern.colt.matrix.doublealgo.Sorting
A prefabricated quicksort.
quickSort - Static variable in class cern.colt.matrix.objectalgo.Sorting
A prefabricated quicksort.
quickSort - Static variable in class cern.colt.matrix.tdouble.algo.DoubleSorting
A prefabricated quicksort.
quickSort - Static variable in class cern.colt.matrix.tfloat.algo.FloatSorting
A prefabricated quicksort.
quickSort - Static variable in class cern.colt.matrix.tint.algo.IntSorting
A prefabricated quicksort.
quickSort - Static variable in class cern.colt.matrix.tlong.algo.LongSorting
A prefabricated quicksort.
quickSort - Static variable in class cern.colt.matrix.tobject.algo.ObjectSorting
A prefabricated quicksort.
quickSort(byte[], int, int, ByteComparator, int) - Static method in class cern.colt.ParallelQuickSort
Multithreaded quicksort.
quickSort(char[], int, int, CharComparator, int) - Static method in class cern.colt.ParallelQuickSort
Multithreaded quicksort.
quickSort(double[], int, int, DoubleComparator, int) - Static method in class cern.colt.ParallelQuickSort
Multithreaded quicksort.
quickSort(float[], int, int, FloatComparator, int) - Static method in class cern.colt.ParallelQuickSort
Multithreaded quicksort.
quickSort(int[], int, int, IntComparator, int) - Static method in class cern.colt.ParallelQuickSort
Multithreaded quicksort.
quickSort(long[], int, int, LongComparator, int) - Static method in class cern.colt.ParallelQuickSort
Multithreaded quicksort.
quickSort(Object[], int, int, int) - Static method in class cern.colt.ParallelQuickSort
Multithreaded quicksort.
quickSort(Object[], int, int, Comparator, int) - Static method in class cern.colt.ParallelQuickSort
Multithreaded quicksort.
quickSort(short[], int, int, ShortComparator, int) - Static method in class cern.colt.ParallelQuickSort
Multithreaded quicksort.
quickSort(byte[], int, int, ByteComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(char[], int, int, CharComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(double[], int, int, DoubleComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(float[], int, int, FloatComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(int[], int, int, IntComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(long[], int, int, LongComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort(Object[]) - Static method in class cern.colt.Sorting
Sorts the specified range of the receiver into ascending order, according to the natural ordering of its elements.
quickSort(Object[], int, int) - Static method in class cern.colt.Sorting
Sorts the specified range of the receiver into ascending order, according to the natural ordering of its elements.
quickSort(Object[], int, int, Comparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array according to the order induced by the specified comparator.
quickSort(Object[], Comparator) - Static method in class cern.colt.Sorting
Sorts the specified array according to the order induced by the specified comparator.
quickSort(short[], int, int, ShortComparator) - Static method in class cern.colt.Sorting
Sorts the specified range of the specified array of elements according to the order induced by the specified comparator.
quickSort() - Method in class umontreal.iro.lecuyer.stat.TallyStore
Sorts the elements of this probe using the quicksort from Colt.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractByteList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, ByteComparator) - Method in class cern.colt.list.AbstractByteList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractCharList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, CharComparator) - Method in class cern.colt.list.AbstractCharList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractDoubleList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, DoubleComparator) - Method in class cern.colt.list.AbstractDoubleList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractFloatList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, FloatComparator) - Method in class cern.colt.list.AbstractFloatList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractIntList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, IntComparator) - Method in class cern.colt.list.AbstractIntList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractList
Sorts the specified range of the receiver into ascending order.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractLongList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, LongComparator) - Method in class cern.colt.list.AbstractLongList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.AbstractShortList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, ShortComparator) - Method in class cern.colt.list.AbstractShortList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Sorts the specified range of the receiver into ascending order (false < true).
quickSortFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Sorts the specified range of the receiver into ascending order, according to the natural ordering of its elements.
quickSortFromTo(int, int, Comparator) - Method in class cern.colt.list.ObjectArrayList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Sorts the specified range of the receiver into ascending order ( false < true).
quickSortFromTo(int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, ByteComparator) - Method in class cern.colt.list.tbyte.AbstractByteList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, CharComparator) - Method in class cern.colt.list.tchar.AbstractCharList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, DoubleComparator) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, FloatComparator) - Method in class cern.colt.list.tfloat.AbstractFloatList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.tint.AbstractIntList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, IntComparator) - Method in class cern.colt.list.tint.AbstractIntList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, LongComparator) - Method in class cern.colt.list.tlong.AbstractLongList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Sorts the specified range of the receiver into ascending order, according to the natural ordering of its elements.
quickSortFromTo(int, int, Comparator) - Method in class cern.colt.list.tobject.ObjectArrayList
Sorts the receiver according to the order induced by the specified comparator.
quickSortFromTo(int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Sorts the specified range of the receiver into ascending numerical order.
quickSortFromTo(int, int, ShortComparator) - Method in class cern.colt.list.tshort.AbstractShortList
Sorts the receiver according to the order induced by the specified comparator.
quit() - Method in class jhplot.HChart
Quit the frame
quit() - Method in class jhplot.HGraph
 
quit() - Method in class jhplot.HPlot
Quit the canvas (and dispose all components) Note: a memory leak is found - no time to study it.
quit() - Method in class jhplot.HPlot2D
Quit the canvas (and dispose all components) Note: a memory leak is found - no time to study it.
quit() - Method in class jhplot.HPlot3D
exit the frame and clear all components
quit() - Method in class jhplot.HPlot3DP
 
quit() - Method in class jhplot.HView3D
 

R

R_GAS - Static variable in class flanagan.math.Fmath
 
RAC2 - Static variable in class umontreal.iro.lecuyer.util.Num
The value of (2)1/2.
rad - Static variable in class cern.clhep.Units
 
radialFrequencyToFrequency(double) - Static method in class flanagan.math.Conv
 
radialFrequencyToFrequency(double) - Static method in class flanagan.math.Fmath
 
radian - Static variable in class cern.clhep.Units
 
RadicalInverse - Class in umontreal.iro.lecuyer.hups
This class implements basic methods for working with radical inverses of integers in an arbitrary basis b.
RadicalInverse(int, double) - Constructor for class umontreal.iro.lecuyer.hups.RadicalInverse
Initializes the base of this object to b and its first value of x to x0.
radicalInverse(int, long) - Static method in class umontreal.iro.lecuyer.hups.RadicalInverse
Computes the radical inverse of i in base b.
RADIX - Static variable in class org.apache.commons.math.dfp.Dfp
The radix, or base of this system.
radToDeg(double) - Static method in class flanagan.math.Conv
 
radToDeg(double) - Static method in class flanagan.math.Fmath
 
raise(double[], double) - Static method in class jhplot.math.LinearAlgebra
Raise each element of an array to a scalar power.
raise(double[][], double) - Static method in class jhplot.math.LinearAlgebra
Raise each element of a matrix to a scalar power
raiseElementsToPower(double[], double) - Static method in class flanagan.math.Fmath
 
raiseElementsToPower(double[], int) - Static method in class flanagan.math.Fmath
 
raiseElementsToPower(float[], float) - Static method in class flanagan.math.Fmath
 
raiseElementsToPower(float[], int) - Static method in class flanagan.math.Fmath
 
rand() - Static method in class jhplot.math.Random
Generate a random number between 0 and 1.
RandEngine - Static variable in class jhplot.math.Random
 
randInt(int, int) - Static method in class jhplot.math.Random
Generate a random integer.
RandMrg - Class in umontreal.iro.lecuyer.rng
Deprecated. 
RandMrg() - Constructor for class umontreal.iro.lecuyer.rng.RandMrg
Deprecated. Constructs a new stream, initializes its seed Ig, sets Bg and Cg equal to Ig, and sets its antithetic switch to false.
RandMrg(String) - Constructor for class umontreal.iro.lecuyer.rng.RandMrg
Deprecated. Constructs a new stream with an identifier name (can be used when printing the stream state, in error messages, etc.).
random(int) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int, int) - Method in class cern.colt.matrix.DoubleFactory3D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory1D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory3D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleFactory3D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory1D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory3D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int, int) - Method in class cern.colt.matrix.tfloat.FloatFactory3D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int) - Method in class cern.colt.matrix.tint.IntFactory1D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int, int) - Method in class cern.colt.matrix.tint.IntFactory3D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int) - Method in class cern.colt.matrix.tlong.LongFactory1D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random(int, int, int) - Method in class cern.colt.matrix.tlong.LongFactory3D
Constructs a matrix with uniformly distributed values in (0,1) (exclusive).
random() - Static method in class cern.jet.math.Functions
Constructs a function that returns a new uniform random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
random() - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a 32 bit uniformly distributed random number in the closed interval [Integer.MIN_VALUE,Integer.MAX_VALUE] (including Integer.MIN_VALUE and Integer.MAX_VALUE).
random() - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
random() - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns a new uniform random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
random() - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
random() - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns a new uniform random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
random() - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a 32 bit uniformly distributed random number in the closed longerval [Int.MIN_VALUE,Int.MAX_VALUE] (including Int.MIN_VALUE and Int.MAX_VALUE).
random() - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a 32 bit uniformly distributed random number in the closed longerval [Long.MIN_VALUE,Long.MAX_VALUE] (including Long.MIN_VALUE and Long.MAX_VALUE).
random(int, boolean, double, String) - Static method in class cern.jet.random.Benchmark
Benchmarks all subclasses
random(int, int, int) - Static method in class jhplot.bsom.Matrix
Make a standard Gaussian random Matrix.
random(int, int) - Static method in class jhplot.bsom.Matrix
Same as random(row, col, 1).
random(int, int) - Static method in class jhplot.math.DoubleArray
Generates an m x n matrix of random numbers uniformly distributed between 0 and 1.
random(int) - Static method in class jhplot.math.DoubleArray
Generates an m element array of random numbers uniformly distributed between 0 and 1.
random(int, int, double, double) - Static method in class jhplot.math.DoubleArray
Generates an mxn matrix of random numbers uniformly distributed between min and max.
random(int, double, double) - Static method in class jhplot.math.DoubleArray
Generates an m element array of random numbers uniformly distributed between min and max.
random(int, int, double[], double[]) - Static method in class jhplot.math.DoubleArray
Generates an m x n matrix of random numbers uniformly distributed numbers.
Random - Class in jhplot.math
BSD License
Random() - Constructor for class jhplot.math.Random
 
random(int, AbstractDistribution) - Method in class jhplot.P0D
Fill array with random numbers Random generators are taken from cern.jet.random.*.
random(int, AbstractDistribution) - Method in class jhplot.P0I
Fill array with random numbers
random() - Static method in class org.apache.commons.math.util.FastMath
Returns a pseudo-random number between 0.0 and 1.0.
RandomAdaptor - Class in org.apache.commons.math.random
Extension of java.util.Random wrapping a RandomGenerator.
RandomAdaptor(RandomGenerator) - Constructor for class org.apache.commons.math.random.RandomAdaptor
Construct a RandomAdaptor wrapping the supplied RandomGenerator.
randomBeta(int, int, double, double) - Static method in class jhplot.math.StatisticSample
Random beata distribution
randomBeta(int, double, double) - Static method in class jhplot.math.StatisticSample
1D Random Beta distribution
randomBinaryRepresentation(int) - Static method in class org.apache.commons.math.genetics.BinaryChromosome
Returns a representation of a random binary array of length length.
randomCauchy(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D Cauchy PDF
randomCauchy(int, double, double) - Static method in class jhplot.math.StatisticSample
1D Cauchy PDF
randomChi2(int, int, int) - Static method in class jhplot.math.StatisticSample
2D array with Chi2
randomChi2(int, int) - Static method in class jhplot.math.StatisticSample
1D array with random numbers
RandomData - Interface in org.apache.commons.math.random
Random data generation utilities.
RandomDataImpl - Class in org.apache.commons.math.random
Implements the RandomData interface using a RandomGenerator instance to generate non-secure data and a SecureRandom instance to provide data for the nextSecureXxx methods.
RandomDataImpl() - Constructor for class org.apache.commons.math.random.RandomDataImpl
Construct a RandomDataImpl.
RandomDataImpl(RandomGenerator) - Constructor for class org.apache.commons.math.random.RandomDataImpl
Construct a RandomDataImpl using the supplied RandomGenerator as the source of (non-secure) random data.
randomDirac(int, int, double[], double[]) - Static method in class jhplot.math.StatisticSample
2D array with Dirac random values
randomDirac(int, double[], double[]) - Static method in class jhplot.math.StatisticSample
1D array with Dirac random values
randomDoubleArray(int, int, AbstractDistribution) - Method in class jhplot.math.StatisticSample
Build 2D integer array list with integer numbers from input random number generator
randomDoubleArrayList(int, AbstractDistribution) - Method in class jhplot.math.StatisticSample
Build double array list with integer numbers from input random number generator
RandomEngine - Class in cern.jet.random.engine
Abstract base class for uniform pseudo-random number generating engines.
randomExponential(int, int, double) - Static method in class jhplot.math.StatisticSample
2D array with exponential random distribution
randomExponential(int, double) - Static method in class jhplot.math.StatisticSample
1D array with exponential numbers
RandomGenerator - Interface in cern.jet.random.engine
Interface for uniform pseudo-random number generators.
RandomGenerator - Interface in cern.jet.random.tdouble.engine
Interface for uniform pseudo-random number generators.
RandomGenerator - Interface in org.apache.commons.math.random
Interface extracted from java.util.Random.
randomInstance(int, boolean, AbstractDistribution) - Static method in class cern.jet.random.Benchmark
generates random numbers from
randomInt(int, int, int, int) - Static method in class jhplot.math.StatisticSample
Random 2D array with integers
randomInt(int, int, int) - Static method in class jhplot.math.StatisticSample
Random array with integers
randomIntArray(int, Binomial) - Method in class jhplot.math.StatisticSample
Build integer array list with integer numbers from input random number generator
randomIntArray(int, int, AbstractDistribution) - Method in class jhplot.math.StatisticSample
Build 2D integer array list with integer numbers from input random number generator
randomIntArrayList(int, AbstractDistribution) - Method in class jhplot.math.StatisticSample
Build integer array list with integer numbers from input random number generator
randomise() - Method in class flanagan.analysis.Stat
 
randomise() - Method in class flanagan.math.ArrayMaths
 
Randomization - Interface in umontreal.iro.lecuyer.hups
Deprecated. 
randomize() - Method in class flanagan.analysis.Stat
 
randomize() - Method in class flanagan.math.ArrayMaths
 
randomize(PointSetRandomization) - Method in class umontreal.iro.lecuyer.hups.CachedPointSet
Randomizes the underlying point set using rand and recaches the points.
randomize(PointSetRandomization) - Method in class umontreal.iro.lecuyer.hups.ContainerPointSet
Randomizes the contained point set using rand.
randomize(PointSet) - Method in class umontreal.iro.lecuyer.hups.EmptyRandomization
This method does nothing.
randomize(PointSet) - Method in class umontreal.iro.lecuyer.hups.LMScrambleShift
This method calls leftMatrixScramble, then addRandomShift.
randomize(RandomStream) - Method in class umontreal.iro.lecuyer.hups.PaddedPointSet
 
randomize(PointSetRandomization) - Method in class umontreal.iro.lecuyer.hups.PointSet
Randomizes the point set using the given rand.
randomize(int, int, RandomStream) - Method in class umontreal.iro.lecuyer.hups.PointSet
By default, this method simply calls addRandomShift(d1, d2, stream).
randomize(RandomStream) - Method in class umontreal.iro.lecuyer.hups.PointSet
By default, this method simply calls addRandomShift(stream).
randomize(int, int) - Method in class umontreal.iro.lecuyer.hups.PointSet
Deprecated. 
randomize() - Method in class umontreal.iro.lecuyer.hups.PointSet
Deprecated. 
randomize(PointSet) - Method in interface umontreal.iro.lecuyer.hups.PointSetRandomization
This method must randomize p.
randomize(PointSet) - Method in class umontreal.iro.lecuyer.hups.RandomShift
This method calls addRandomShift (stream).
randomize(PointSet) - Method in class umontreal.iro.lecuyer.hups.SMScrambleShift
This method calls stripedMatrixScramble, then addRandomShift.
RandomKey<T> - Class in org.apache.commons.math.genetics
Random Key chromosome is used for permutation representation.
RandomKey(List<Double>) - Constructor for class org.apache.commons.math.genetics.RandomKey
Constructor.
RandomKey(Double[]) - Constructor for class org.apache.commons.math.genetics.RandomKey
Constructor.
RandomKeyMutation - Class in org.apache.commons.math.genetics
Mutation operator for RandomKeys.
RandomKeyMutation() - Constructor for class org.apache.commons.math.genetics.RandomKeyMutation
 
randomLogNormal(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D Log-normal distribution
randomLogNormal(int, double, double) - Static method in class jhplot.math.StatisticSample
1D array with random Log-normal values
RandomMultivariateGen - Class in umontreal.iro.lecuyer.randvarmulti
This class is the multivariate counterpart of RandomVariateGen.
RandomMultivariateGen() - Constructor for class umontreal.iro.lecuyer.randvarmulti.RandomMultivariateGen
 
randomNormal(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D array with Gaussian numbers
randomNormal(int, double, double) - Static method in class jhplot.math.StatisticSample
1D array with Gaussian numbers
randomNormal(int, double, double) - Method in class jhplot.P0D
Fill with random numbers distributed using the normal (gaussian) distribution.
randomNormal(int, double, double) - Method in class jhplot.P0I
Fill with random numbers distributed using the normal (gaussian) distribution.
randomPermutation(int) - Static method in class org.apache.commons.math.genetics.RandomKey
Generates a representation corresponding to a random permutation of length l which can be passed to the RandomKey constructor.
RandomPermutation - Class in umontreal.iro.lecuyer.rng
Provides methods to randomly shuffle arrays or lists using a random stream.
RandomPermutation() - Constructor for class umontreal.iro.lecuyer.rng.RandomPermutation
 
randomPoisson(int, double) - Static method in class jhplot.math.StatisticSample
Build an array with Poisson distribution
randomRejection(int, int, ParseFunction, double, double, double) - Static method in class jhplot.math.StatisticSample
Build 2D random array using analytic function.
randomRejection(int, ParseFunction, double, double, double) - Static method in class jhplot.math.StatisticSample
Build 1D array using analytic function.
RandomRNG - Class in jhplot.math.num.random
A random number generator that delegates random number generation to a Random object.
RandomRNG() - Constructor for class jhplot.math.num.random.RandomRNG
Create a random number generator using a default Random delegate.
RandomRNG(long) - Constructor for class jhplot.math.num.random.RandomRNG
Create a random number generator using a Random delegate initialized with the given seed.
RandomRNG(Random) - Constructor for class jhplot.math.num.random.RandomRNG
Create a random number generator using the given Random delegate.
RandomSampler - Class in cern.jet.random.sampling
Space and time efficiently computes a sorted Simple Random Sample Without Replacement (SRSWOR), that is, a sorted set of n random numbers from an interval of N numbers; Example: Computing n=3 random numbers from the interval [1,50] may yield the sorted random set (7,13,47).
RandomSampler(long, long, long, RandomEngine) - Constructor for class cern.jet.random.sampling.RandomSampler
Constructs a random sampler that computes and delivers sorted random sets in blocks.
RandomSamplingAssistant - Class in cern.jet.random.sampling
Conveniently computes a stable Simple Random Sample Without Replacement (SRSWOR) subsequence of n elements from a given input sequence of N elements; Example: Computing a sublist of n=3 random elements from a list (1,...,50) may yield the sublist (7,13,47).
RandomSamplingAssistant(long, long, RandomEngine) - Constructor for class cern.jet.random.sampling.RandomSamplingAssistant
Constructs a random sampler that samples n random elements from an input sequence of N elements.
RandomSeedGenerator - Class in cern.jet.random.engine
Deterministic seed generator for pseudo-random number generators.
RandomSeedGenerator() - Constructor for class cern.jet.random.engine.RandomSeedGenerator
Constructs and returns a new seed generator.
RandomSeedGenerator(int, int) - Constructor for class cern.jet.random.engine.RandomSeedGenerator
Constructs and returns a new seed generator; you normally won't need to use this method.
RandomSeedGenerator - Class in cern.jet.random.tdouble.engine
Deterministic seed generator for pseudo-random number generators.
RandomSeedGenerator() - Constructor for class cern.jet.random.tdouble.engine.RandomSeedGenerator
Constructs and returns a new seed generator.
RandomSeedGenerator(int, int) - Constructor for class cern.jet.random.tdouble.engine.RandomSeedGenerator
Constructs and returns a new seed generator; you normally won't need to use this method.
RandomSeedTable - Class in cern.jet.random.engine
(Seemingly gigantic) table of good seeds for pseudo-random number generators.
RandomSeedTable - Class in cern.jet.random.tdouble.engine
(Seemingly gigantic) table of good seeds for pseudo-random number generators.
RandomShift - Class in umontreal.iro.lecuyer.hups
This class implements a PointSetRandomization.
RandomShift() - Constructor for class umontreal.iro.lecuyer.hups.RandomShift
Empty constructor.
RandomShift(RandomStream) - Constructor for class umontreal.iro.lecuyer.hups.RandomShift
Sets the internal RandomStream to stream.
RandomStream - Interface in umontreal.iro.lecuyer.rng
This interface defines the basic structures to handle multiple streams of uniform (pseudo)random numbers and convenient tools to move around within and across these streams.
RandomStreamBase - Class in umontreal.iro.lecuyer.rng
This class provides a convenient foundation on which RNGs can be built.
RandomStreamBase() - Constructor for class umontreal.iro.lecuyer.rng.RandomStreamBase
 
RandomStreamFactory - Interface in umontreal.iro.lecuyer.rng
Represents a random stream factory capable of constructing instances of a given type of random stream by invoking the newInstance method each time a new random stream is needed, instead of invoking directly the specific constructor of the desired type.
RandomStreamInstantiationException - Exception in umontreal.iro.lecuyer.rng
This exception is thrown when a random stream factory cannot instantiate a stream on a call to its newInstance method.
RandomStreamInstantiationException(RandomStreamFactory) - Constructor for exception umontreal.iro.lecuyer.rng.RandomStreamInstantiationException
Constructs a new random stream instantiation exception with no message, no cause, and thrown by the given factory.
RandomStreamInstantiationException(RandomStreamFactory, String) - Constructor for exception umontreal.iro.lecuyer.rng.RandomStreamInstantiationException
Constructs a new random stream instantiation exception with the given message, no cause, and concerning factory.
RandomStreamInstantiationException(RandomStreamFactory, Throwable) - Constructor for exception umontreal.iro.lecuyer.rng.RandomStreamInstantiationException
Constructs a new random stream instantiation exception with no message, the given cause, and concerning factory.
RandomStreamInstantiationException(RandomStreamFactory, String, Throwable) - Constructor for exception umontreal.iro.lecuyer.rng.RandomStreamInstantiationException
Constructs a new random stream instantiation exception with the given message, the supplied cause, and concerning factory.
RandomStreamManager - Class in umontreal.iro.lecuyer.rng
Manages a list of random streams for more convenient synchronization.
RandomStreamManager() - Constructor for class umontreal.iro.lecuyer.rng.RandomStreamManager
 
RandomStreamWithCache - Class in umontreal.iro.lecuyer.rng
This class represents a random stream whose uniforms are cached for more efficiency when using common random numbers.
RandomStreamWithCache(RandomStream) - Constructor for class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Constructs a new cached random stream with internal stream stream.
RandomStreamWithCache(RandomStream, int) - Constructor for class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Constructs a new cached random stream with internal stream stream.
randomTriangular(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D array for Triangular random PDF
randomTriangular(int, double, double) - Static method in class jhplot.math.StatisticSample
1D array with Triangular random PDF
randomTriangular(int, int, double, double, double) - Static method in class jhplot.math.StatisticSample
2D array for Triangular
randomTriangular(int, double, double, double) - Static method in class jhplot.math.StatisticSample
1D array for Triangular
randomUniform(int, double, double) - Method in class jhplot.P0D
Fill with with uniform random numbers between min and max.
randomUniform(int, Integer, Integer) - Method in class jhplot.P0I
Fill with with uniform random numbers between min and max.
RandomVariateGen - Class in umontreal.iro.lecuyer.randvar
This is the base class for all random variate generators over the real line.
RandomVariateGen(RandomStream, Distribution) - Constructor for class umontreal.iro.lecuyer.randvar.RandomVariateGen
Creates a new random variate generator from the distribution dist, using stream s.
RandomVariateGenInt - Class in umontreal.iro.lecuyer.randvar
This is the base class for all generators of discrete random variates over the set of integers.
RandomVariateGenInt(RandomStream, DiscreteDistributionInt) - Constructor for class umontreal.iro.lecuyer.randvar.RandomVariateGenInt
Creates a new random variate generator for the discrete distribution dist, using stream s.
RandomVariateGenWithCache - Class in umontreal.iro.lecuyer.randvar
This class represents a random variate generator whose values are cached for more efficiency when using common random numbers.
RandomVariateGenWithCache(RandomVariateGen) - Constructor for class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Constructs a new cached random variate generator with internal generator rvg.
RandomVariateGenWithCache(RandomVariateGen, int) - Constructor for class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Constructs a new cached random variate generator with internal generator rvg.
RandomVectorGenerator - Interface in org.apache.commons.math.random
This interface represents a random generator for whole vectors.
randomWeibull(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D Weibull
randomWeibull(int, double, double) - Static method in class jhplot.math.StatisticSample
1D Weibull
RandRijndael - Class in umontreal.iro.lecuyer.rng
Implements a RNG using the Rijndael block cipher algorithm (AES) with key and block lengths of 128 bits.
RandRijndael() - Constructor for class umontreal.iro.lecuyer.rng.RandRijndael
Constructs a new stream.
RandRijndael(String) - Constructor for class umontreal.iro.lecuyer.rng.RandRijndael
Constructs a new stream with the identifier name (used in the toString method).
RandShiftedPointSet - Class in umontreal.iro.lecuyer.hups
This container class embodies a point set to which a random shift modulo 1 is applied (i.e., a single uniform random point is added to all points, modulo 1, to randomize the inner point set).
RandShiftedPointSet(PointSet, int, RandomStream) - Constructor for class umontreal.iro.lecuyer.hups.RandShiftedPointSet
Constructs a structure to contain a randomly shifted version of P.
randUniform(int, double, double) - Static method in class jhplot.math.StatisticSample
2D array with uniform values
randUniform(int, int, double, double) - Static method in class jhplot.math.StatisticSample
2D array with random uniform values
range() - Method in class flanagan.math.Matrix
 
range(int) - Method in class hep.aida.ref.fitter.fitdata.FitData
 
Range - Class in hep.aida.ref.function
Implementation of IRange.
Range() - Constructor for class hep.aida.ref.function.Range
Creates a new instance of Range.
Range(double, double) - Constructor for class hep.aida.ref.function.Range
Creates a new instance of Range with type INCLUDE_BOUNDS.
Range(double, double, int) - Constructor for class hep.aida.ref.function.Range
Creates a new instance of Range.
range(double, double, double) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for a to b with steps of size step.
range(double, double) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for a to b inclusively with steps of size 1.
range(double[]) - Static method in class jhplot.math.ArrayMathUtils
returns the difference between the max and the min element
range(double) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for 0 to b with steps of size 1.
range(int, int) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for a to b with steps of size 1.
range(int) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for 0 to b with steps of size 1.
range(int, int, int) - Static method in class jhplot.math.ArrayMathUtils
Generates an array going for a to b with steps of size step.
range(int, int) - Method in class jhplot.P0D
Get range between min and max
range(int, int) - Method in class jhplot.P0I
Get range between min and max
range(int, int) - Method in class jhplot.P1D
Construct P1D in the range between Min and Max indexes.
range(int, double, double) - Method in class jhplot.P1D
Construct P1D in the range between Min and Max.
RANGE_CHANGED - Static variable in class hep.aida.ref.function.FunctionChangedEvent
 
rangeCut(int, double, double) - Method in class jhplot.P1D
Construct P1D removing a range of values defined by Min and Max.
RangeSet - Class in hep.aida.ref.function
This class handles multiple ranges along one axis.
RangeSet() - Constructor for class hep.aida.ref.function.RangeSet
Creates RangeSet with (-infinity, +infinity) valid interval, borders excluded
RangeSet(double, double) - Constructor for class hep.aida.ref.function.RangeSet
 
RangeSet(double[], double[]) - Constructor for class hep.aida.ref.function.RangeSet
 
RangeSet(String) - Constructor for class hep.aida.ref.function.RangeSet
Create a RangeSet from a String.
RangeSetFilter - Class in hep.aida.ref.fitter.fitdata
 
RangeSetFilter(IRangeSet[]) - Constructor for class hep.aida.ref.fitter.fitdata.RangeSetFilter
 
rank(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the effective numerical rank of matrix A, obtained from Singular Value Decomposition.
rank() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns the effective numerical matrix rank, which is the number of nonnegligible singular values.
rank() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleSingularValueDecomposition
Returns the effective numerical matrix rank, which is the number of nonnegligible singular values.
rank(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the effective numerical rank of matrix A, obtained from Singular Value Decomposition.
rank() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatSingularValueDecomposition
Returns the effective numerical matrix rank, which is the number of nonnegligible singular values.
rank(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the effective numerical rank of matrix A, obtained from Singular Value Decomposition.
rank(double) - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Returns the rank of a given element within the sorted sequence of the receiver.
rank(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
rank() - Method in class jhplot.math.SingularValueDecomposition
Effective numerical matrix rank
rank(double[]) - Method in class org.apache.commons.math.stat.ranking.NaturalRanking
Rank data using the natural ordering on Doubles, with NaN values handled according to nanStrategy and ties resolved using tiesStrategy.
rank(double[]) - Method in interface org.apache.commons.math.stat.ranking.RankingAlgorithm
Performs a rank transformation on the input data, returning an array of ranks.
Rank1Lattice - Class in umontreal.iro.lecuyer.hups
This class implements point sets defined by integration lattices of rank 1, defined as follows.
Rank1Lattice(int, int[], int) - Constructor for class umontreal.iro.lecuyer.hups.Rank1Lattice
Instantiates a Rank1Lattice with n points and lattice vector a of dimension s.
RankAnalysis - Class in flanagan.analysis
 
RankAnalysis(double[][], double[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(float[][], float[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(long[][], long[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(int[][], int[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(BigDecimal[][], BigDecimal[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(BigInteger[][], BigInteger[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(ArrayMaths[], ArrayMaths[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(ArrayList<Object>[], ArrayList<Object>[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(Vector<Object>[], Vector<Object>[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(Matrix, Matrix) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(double[][], double[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(float[][], float[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(long[][], long[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(int[][], int[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(BigDecimal[][], BigDecimal[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(BigInteger[][], BigInteger[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(ArrayMaths[], ArrayMaths) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(ArrayList<Object>[], ArrayList<Object>) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(Vector<Object>[], Vector<Object>) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(Scores) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(Cronbach) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(PCA) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(double[][], double) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(float[][], float) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(long[][], long) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(int[][], int) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(BigDecimal[][], BigDecimal) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(BigInteger[][], BigInteger) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(ArrayMaths[], double) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(ArrayList<Object>[], double) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(Vector<Object>[], double) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(Matrix, double) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(double[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(float[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(long[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(int[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(BigDecimal[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(BigInteger[][]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(ArrayMaths[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(ArrayList<Object>[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(Vector<Object>[]) - Constructor for class flanagan.analysis.RankAnalysis
 
RankAnalysis(Matrix) - Constructor for class flanagan.analysis.RankAnalysis
 
RankingAlgorithm - Interface in org.apache.commons.math.stat.ranking
Interface representing a rank transformation.
rankInterpolated(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the linearly interpolated number of elements in a list less or equal to a given element.
rankInterpolated(DoubleArrayList, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the linearly interpolated number of elements in a list less or equal to a given element.
rankInterpolated(FloatArrayList, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the linearly interpolated number of elements in a list less or equal to a given element.
rapidity() - Method in class hephysics.vec.Hep3Vector
Rapidity.
rapidity() - Method in class hephysics.vec.HepLorentzVector
Rapidity.
RatioFunction - Class in umontreal.iro.lecuyer.util
Represents a function computing a ratio of two values.
RatioFunction() - Constructor for class umontreal.iro.lecuyer.util.RatioFunction
Constructs a new ratio function.
RatioFunction(double) - Constructor for class umontreal.iro.lecuyer.util.RatioFunction
Constructs a new ratio function that returns zeroOverZero for the special case of 0/0.
raw() - Method in class cern.jet.random.engine.MersenneTwister64
Returns a 64 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
raw() - Method in class cern.jet.random.engine.RandomEngine
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
raw() - Method in interface cern.jet.random.engine.RandomGenerator
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
raw() - Method in class cern.jet.random.tdouble.engine.DoubleRandomEngine
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
raw() - Method in class cern.jet.random.tdouble.engine.MersenneTwister64
Returns a 64 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
raw() - Method in interface cern.jet.random.tdouble.engine.RandomGenerator
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
raw() - Method in class cern.jet.random.tfloat.engine.FloatRandomEngine
Returns a 32 bit uniformly distributed random number in the open unit interval (0.0,1.0) (excluding 0.0 and 1.0).
raw() - Static method in class jhplot.math.Random
Generate a random number between 0 and 1.
rawAllResponsesMaximum() - Method in class flanagan.analysis.Scores
 
rawAllResponsesMean() - Method in class flanagan.analysis.Scores
 
rawAllResponsesMinimum() - Method in class flanagan.analysis.Scores
 
rawAllResponsesRange() - Method in class flanagan.analysis.Scores
 
rawAllResponsesStandardDeviation() - Method in class flanagan.analysis.Scores
 
rawAllResponsesTotal() - Method in class flanagan.analysis.Scores
 
rawAllResponsesVariance() - Method in class flanagan.analysis.Scores
 
rawAlpha() - Method in class flanagan.analysis.Cronbach
 
rawAverageCorrelationCoefficients() - Method in class flanagan.analysis.Scores
 
rawAverageCorrelationCoefficientsWithTotals() - Method in class flanagan.analysis.Scores
 
rawCorrelationCoefficient(String, String) - Method in class flanagan.analysis.Scores
 
rawCorrelationCoefficient(int, int) - Method in class flanagan.analysis.Scores
 
rawCorrelationCoefficient(String) - Method in class flanagan.analysis.Scores
 
rawCorrelationCoefficient(int) - Method in class flanagan.analysis.Scores
 
rawCorrelationCoefficients() - Method in class flanagan.analysis.Scores
 
rawCovariance(String, String) - Method in class flanagan.analysis.Scores
 
rawCovariance(int, int) - Method in class flanagan.analysis.Scores
 
rawCovariance(String) - Method in class flanagan.analysis.Scores
 
rawCovariance(int) - Method in class flanagan.analysis.Scores
 
rawCovariances() - Method in class flanagan.analysis.Scores
 
rawItemItemPlot(String, String) - Method in class flanagan.analysis.Scores
 
rawItemItemPlot(int, int) - Method in class flanagan.analysis.Scores
 
rawItemMaxima() - Method in class flanagan.analysis.Scores
 
rawItemMaximum(int) - Method in class flanagan.analysis.Scores
 
rawItemMean(String) - Method in class flanagan.analysis.Scores
 
rawItemMean(int) - Method in class flanagan.analysis.Scores
 
rawItemMeans() - Method in class flanagan.analysis.Scores
 
rawItemMeansPlot(String) - Method in class flanagan.analysis.Scores
 
rawItemMeansPlot(int) - Method in class flanagan.analysis.Scores
 
rawItemMedian(String) - Method in class flanagan.analysis.Scores
 
rawItemMedian(int) - Method in class flanagan.analysis.Scores
 
rawItemMedians() - Method in class flanagan.analysis.Scores
 
rawItemMinima() - Method in class flanagan.analysis.Scores
 
rawItemMinimum(int) - Method in class flanagan.analysis.Scores
 
rawItemRange(int) - Method in class flanagan.analysis.Scores
 
rawItemRanges() - Method in class flanagan.analysis.Scores
 
rawItemStandardDeviation(String) - Method in class flanagan.analysis.Scores
 
rawItemStandardDeviation(int) - Method in class flanagan.analysis.Scores
 
rawItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
rawItemTotal(String) - Method in class flanagan.analysis.Scores
 
rawItemTotal(int) - Method in class flanagan.analysis.Scores
 
rawItemTotals() - Method in class flanagan.analysis.Scores
 
rawItemVariance(String) - Method in class flanagan.analysis.Scores
 
rawItemVariance(int) - Method in class flanagan.analysis.Scores
 
rawItemVariances() - Method in class flanagan.analysis.Scores
 
rawMaximumOfItemMaxima() - Method in class flanagan.analysis.Scores
 
rawMaximumOfItemMeans() - Method in class flanagan.analysis.Scores
 
rawMaximumOfItemMedians() - Method in class flanagan.analysis.Scores
 
rawMaximumOfItemMinima() - Method in class flanagan.analysis.Scores
 
rawMaximumOfItemRanges() - Method in class flanagan.analysis.Scores
 
rawMaximumOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
rawMaximumOfItemTotals() - Method in class flanagan.analysis.Scores
 
rawMaximumOfItemVariances() - Method in class flanagan.analysis.Scores
 
rawMeanOfItemMaxima() - Method in class flanagan.analysis.Scores
 
rawMeanOfItemMeans() - Method in class flanagan.analysis.Scores
 
rawMeanOfItemMedians() - Method in class flanagan.analysis.Scores
 
rawMeanOfItemMinima() - Method in class flanagan.analysis.Scores
 
rawMeanOfItemRanges() - Method in class flanagan.analysis.Scores
 
rawMeanOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
rawMeanOfItemTotals() - Method in class flanagan.analysis.Scores
 
rawMeanOfItemVariances() - Method in class flanagan.analysis.Scores
 
rawMinimumOfItemMaxima() - Method in class flanagan.analysis.Scores
 
rawMinimumOfItemMeans() - Method in class flanagan.analysis.Scores
 
rawMinimumOfItemMedians() - Method in class flanagan.analysis.Scores
 
rawMinimumOfItemMinima() - Method in class flanagan.analysis.Scores
 
rawMinimumOfItemRanges() - Method in class flanagan.analysis.Scores
 
rawMinimumOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
rawMinimumOfItemTotals() - Method in class flanagan.analysis.Scores
 
rawMinimumOfItemVariances() - Method in class flanagan.analysis.Scores
 
rawPersonMaxima() - Method in class flanagan.analysis.Scores
 
rawPersonMaximum(int) - Method in class flanagan.analysis.Scores
 
rawPersonMean(int) - Method in class flanagan.analysis.Scores
 
rawPersonMeans() - Method in class flanagan.analysis.Scores
 
rawPersonMinima() - Method in class flanagan.analysis.Scores
 
rawPersonMinimum(int) - Method in class flanagan.analysis.Scores
 
rawPersonRange(int) - Method in class flanagan.analysis.Scores
 
rawPersonRanges() - Method in class flanagan.analysis.Scores
 
rawPersonStandardDeviation(int) - Method in class flanagan.analysis.Scores
 
rawPersonStandardDeviations() - Method in class flanagan.analysis.Scores
 
rawPersonTotal(int) - Method in class flanagan.analysis.Scores
 
rawPersonTotals() - Method in class flanagan.analysis.Scores
 
rawPersonVariance(int) - Method in class flanagan.analysis.Scores
 
rawPersonVariances() - Method in class flanagan.analysis.Scores
 
rawRangeOfItemMaxima() - Method in class flanagan.analysis.Scores
 
rawRangeOfItemMeans() - Method in class flanagan.analysis.Scores
 
rawRangeOfItemMedians() - Method in class flanagan.analysis.Scores
 
rawRangeOfItemMinima() - Method in class flanagan.analysis.Scores
 
rawRangeOfItemRanges() - Method in class flanagan.analysis.Scores
 
rawRangeOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
rawRangeOfItemTotals() - Method in class flanagan.analysis.Scores
 
rawRangeOfItemVariances() - Method in class flanagan.analysis.Scores
 
rawStanadarDeviationOfItemMaxima() - Method in class flanagan.analysis.Scores
 
rawStanadarDeviationOfItemMedians() - Method in class flanagan.analysis.Scores
 
rawStanadarDeviationOfItemMinima() - Method in class flanagan.analysis.Scores
 
rawStanadarDeviationOfItemRanges() - Method in class flanagan.analysis.Scores
 
rawStanadarDeviationOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
rawStanadarDeviationOfItemTotals() - Method in class flanagan.analysis.Scores
 
rawStanadarDeviationOfItemVariances() - Method in class flanagan.analysis.Scores
 
rawStandardDeviationCorrelationCoefficients() - Method in class flanagan.analysis.Scores
 
rawStandardDeviationCorrelationCoefficientsWithTotals() - Method in class flanagan.analysis.Scores
 
rawStandardDeviationOfItemMeans() - Method in class flanagan.analysis.Scores
 
rawVarianceOfItemMaxima() - Method in class flanagan.analysis.Scores
 
rawVarianceOfItemMeans() - Method in class flanagan.analysis.Scores
 
rawVarianceOfItemMedians() - Method in class flanagan.analysis.Scores
 
rawVarianceOfItemMinima() - Method in class flanagan.analysis.Scores
 
rawVarianceOfItemRanges() - Method in class flanagan.analysis.Scores
 
rawVarianceOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
rawVarianceOfItemTotals() - Method in class flanagan.analysis.Scores
 
rawVarianceOfItemVariances() - Method in class flanagan.analysis.Scores
 
rawVarimaxRotation(int) - Method in class flanagan.analysis.PCA
 
rawVarimaxRotation(double[][]) - Static method in class flanagan.analysis.PCA
 
rawVarimaxRotation(double[][], double, int) - Static method in class flanagan.analysis.PCA
 
rayleigh() - Method in class flanagan.analysis.Regression
 
rayleigh(double, double) - Static method in class flanagan.analysis.Stat
 
Rayleigh - Class in jhplot.math.num.pdf
The Rayleigh distribution.
Rayleigh() - Constructor for class jhplot.math.num.pdf.Rayleigh
Default constructor.
Rayleigh(double) - Constructor for class jhplot.math.num.pdf.Rayleigh
Create a distribution with the scale parameter.
rayleighArray(double, int) - Method in class flanagan.math.PsRandom
 
rayleighBeta() - Method in class flanagan.analysis.ProbabilityPlot
 
rayleighBetaError() - Method in class flanagan.analysis.ProbabilityPlot
 
rayleighCDF(double, double) - Static method in class flanagan.analysis.Stat
 
rayleighCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
rayleighCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
RayleighDist - Class in umontreal.iro.lecuyer.probdist
This class extends the class ContinuousDistribution for the Rayleigh distribution with location parameter a, and scale parameter β > 0.
RayleighDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.RayleighDist
Constructs a RayleighDist object with parameters a = 0 and β = beta.
RayleighDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.RayleighDist
Constructs a RayleighDist object with parameters a = a, and β = beta.
RayleighGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the Rayleigh distribution.
RayleighGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.RayleighGen
Creates a Rayleigh random variate generator with parameters a = a and β = beta, using stream s.
RayleighGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.RayleighGen
Creates a Rayleigh random variate generator with parameters a = 0 and β = beta, using stream s.
RayleighGen(RandomStream, RayleighDist) - Constructor for class umontreal.iro.lecuyer.randvar.RayleighGen
Creates a new generator for the Rayleigh distribution dist and stream s.
rayleighGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
rayleighGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
rayleighIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
rayleighInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
rayleighInverseCDF(double, double) - Static method in class flanagan.analysis.Stat
 
rayleighMean(double) - Static method in class flanagan.analysis.Stat
 
rayleighMedian(double) - Static method in class flanagan.analysis.Stat
 
rayleighMode(double) - Static method in class flanagan.analysis.Stat
 
rayleighOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
rayleighOrderStatisticMedians(double, int) - Static method in class flanagan.analysis.Stat
 
rayleighPDF(double, double) - Static method in class flanagan.analysis.Stat
 
rayleighPlot() - Method in class flanagan.analysis.Regression
 
rayleighProb(double, double) - Static method in class flanagan.analysis.Stat
 
rayleighProb(double, double, double) - Static method in class flanagan.analysis.Stat
 
rayleighProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
rayleighRand(double, int) - Static method in class flanagan.analysis.Stat
 
rayleighRand(double, int, long) - Static method in class flanagan.analysis.Stat
 
RayleighRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Rayleigh distribution.
RayleighRandomVariable() - Constructor for class jhplot.math.num.random.RayleighRandomVariable
Default constructor.
RayleighRandomVariable(double) - Constructor for class jhplot.math.num.random.RayleighRandomVariable
Create a random variable with the given mean.
RayleighRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.RayleighRandomVariable
Create a random variable with the given parameters.
rayleighStandardDeviation(double) - Static method in class flanagan.analysis.Stat
 
rayleighStandDev(double) - Static method in class flanagan.analysis.Stat
 
rayleighSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
RCDoubleMatrix2D - Class in cern.colt.matrix.impl
Sparse row-compressed 2-d matrix holding double elements.
RCDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.impl.RCDoubleMatrix2D
Constructs a matrix with a copy of the given values.
RCDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.impl.RCDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
read(String) - Method in class jhplot.HBook
Read external XML file with all objects (H1D, H2D, P1D)
read(String, String) - Method in class jhplot.HNeuralNet
Read a neural net from a file.
read(String) - Method in class jhplot.HPlot
Read HPlot file and inserts graphs to the main frame.
read() - Method in class jhplot.io.EFile
Read next event
read(int) - Method in class jhplot.io.EFile
Get object from a file using its index.
read() - Method in class jhplot.io.HFile
Get object from a file.
read() - Method in class jhplot.io.HFileXML
Get object from a file.
read(String) - Method in class jhplot.io.PFile
Get object from a file using its name.
read() - Method in class jhplot.io.PFile
Read next object
read(int) - Method in class jhplot.io.PFile
Get object from a file using its index.
read(URL) - Static method in class jhplot.io.PReader
Read data from URL.
read(File) - Static method in class jhplot.io.PReader
Read from a file.
read(String) - Static method in class jhplot.io.PReader
Read data from a given location.
read(File, boolean) - Static method in class jhplot.io.Serialized
Read an object from a serialized file
read(URL, boolean) - Static method in class jhplot.io.Serialized
Read an object from an URL
read(String) - Static method in class jhplot.io.Serialized
Read an object from a serialized file.
read(File) - Static method in class jhplot.math.io.ASCIIFile
 
read() - Method in class jhplot.math.io.ASCIIFile
Read an ASCII File
read() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
read(byte[], int, int) - Method in class jhplot.math.io.LEDataInputStream
 
read(byte[], int, int) - Method in class jhplot.math.io.LERandomAccessFile
 
read(byte[]) - Method in class jhplot.math.io.LERandomAccessFile
 
read() - Method in class jhplot.math.io.LERandomAccessFile
 
read(BufferedReader) - Method in class jhplot.P0D
Read one dimensional data from uncompressed ASCII file.
read(File) - Method in class jhplot.P0D
Read P0D from a file.
read(URL) - Method in class jhplot.P0D
Read data from URL.
read(String) - Method in class jhplot.P0D
Read PNI from a file.
read(File) - Method in class jhplot.P0I
Read P0D from a file.
read(URL) - Method in class jhplot.P0I
Read data from URL.
read(String) - Method in class jhplot.P0I
Read PNI from a file.
read(BufferedReader) - Method in class jhplot.P0I
Read one dimensional data from uncompressed ASCII file.
read(BufferedReader) - Method in class jhplot.P1D
Read data using 10-column format.
read(URL) - Method in class jhplot.P1D
Read data from URL.
read(String) - Method in class jhplot.P1D
Read P1D from a file.
read(BufferedReader) - Method in class jhplot.P2D
Read P2D from a file.
read(File) - Method in class jhplot.P2D
Read P2D from a file.
read(URL) - Method in class jhplot.P2D
Read data from URL.
read(String) - Method in class jhplot.P2D
Read P2D from a file.
read(String) - Method in class jhplot.P3D
Read P3D from a file.
read(BufferedReader) - Method in class jhplot.PND
Read the data from an external source.
read(File) - Method in class jhplot.PND
Read PND from a file.
read(URL) - Method in class jhplot.PND
Read data from URL.
read(String) - Method in class jhplot.PND
Read PND from a file.
read(BufferedReader) - Method in class jhplot.PNI
Read the data from external file.
read(File) - Method in class jhplot.PNI
Read PNI from a file.
read(URL) - Method in class jhplot.PNI
Read data from URL.
read(String) - Method in class jhplot.PNI
Read PNI from a file.
read(String) - Method in class jhplot.SPlot
Read a XML file and build a plot
read(File) - Method in class jhplot.SPlot
Read a XML file and build a plot
read(String) - Method in class jminhep.cluster.DataHolder
Reads the input data from the ARFF file and stores in the data holder
readAll() - Method in class jhplot.io.csv.CSVReader
Reads the entire file into a List with each element being a String[] of tokens.
readArray(double[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads the array data
readArray(float[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads the array data
readArray(int[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads the array data
readArray(long[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads the array data
readArray(double[], double[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads the array data.
readArray(float[], float[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads the array data.
readArraySize() - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads in the size of an array matrix.
readBinary(String) - Method in class jhplot.P0D
Read a P0D from a binary file (big endian by default).
readBinary(String) - Method in class jhplot.P0I
Read a P0I from a binary file (big endian by default).
readBoolean() - Method in class jhplot.math.io.LEDataInputStream
 
readBoolean() - Method in class jhplot.math.io.LERandomAccessFile
 
readByte() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readByte() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readByte() - Method in class jhplot.math.io.LEDataInputStream
 
readByte() - Method in class jhplot.math.io.LERandomAccessFile
 
readByteArray() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readByteArray() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readChar() - Method in class jhplot.math.io.LEDataInputStream
 
readChar() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readChar except little endian.
readComments() - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads all the comments (lines starting with '%').
readCoordinate(int[], double[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate vector
readCoordinate(int[], float[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate vector
readCoordinate(int[], int[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate vector
readCoordinate(int[], long[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate vector
readCoordinate(int[], float[], float[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate vector.
readCoordinate(int[], double[], double[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate vector.
readCoordinate(int[], int[], double[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate matrix
readCoordinate(int[], int[], float[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate matrix
readCoordinate(int[], int[], int[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate matrix
readCoordinate(int[], int[], long[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate matrix
readCoordinate(int[], int[], double[], double[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate matrix.
readCoordinate(int[], int[], float[], float[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a coordinate matrix.
readCoordinateSize() - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads in the size of a coordinate matrix.
readCSVData(Reader, char, char) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Reads comma-separated values (CSV) from reader input, and returns a 2D array of strings corresponding to the read data.
readCSVData(URL, char, char) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Connects to the URL referred to by the URL object url, and calls readCSVData to obtain a matrix of strings from the resource.
readCSVData(File, char, char) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
This is equivalent to readDoubleData2D, for reading strings.
readCSVData(String, char, char) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
This is equivalent to readDoubleData2D, for reading strings.
readDouble() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readDouble() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readDouble() - Method in class jhplot.math.io.LEDataInputStream
 
readDouble() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readDouble except little endian.
readDouble1DArray(File) - Static method in class jhplot.math.io.ASCIIFile
 
readDoubleArray(File) - Static method in class jhplot.math.io.ASCIIFile
 
readDoubleArray(File, String) - Static method in class jhplot.math.io.BinaryFile
 
readDoubleArray() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readDoubleArray(InputStream, String) - Static method in class jhplot.math.io.BinaryInputStream
 
readDoubleArray() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readDoubleArray(int, int) - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readDoubleData(Statement, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into an array of double-precision values.
readDoubleData(Connection, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into an array of double-precision values.
readDoubleData(Statement, String, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the column column of the table table.
readDoubleData(Connection, String, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the column column of the table table.
readDoubleData(Reader) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Reads an array of double-precision values from the reader input.
readDoubleData(URL) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Connects to the URL referred to by the URL object url, and calls readDoubleData to obtain an array of double-precision values from the resource.
readDoubleData(File) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Opens the file referred to by the file object file, and calls readDoubleData to obtain an array of double-precision values from the file.
readDoubleData(String) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Opens the file with name file, and calls readDoubleData to obtain an array of double-precision values from the file.
readDoubleData2D(Statement, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into a rectangular 2D array of double-precision values.
readDoubleData2D(Connection, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into a rectangular 2D array of double-precision values.
readDoubleData2D(Reader) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Uses the reader input to obtain a 2-dimensional array of double-precision values.
readDoubleData2D(URL) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Connects to the URL referred to by the URL object url, and calls readDoubleData2D to obtain a matrix of double-precision values from the resource.
readDoubleData2D(File) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Opens the file referred to by the file object file, and calls readDoubleData2D to obtain a matrix of double-precision values from the file.
readDoubleData2D(String) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Opens the file with name file, and calls readDoubleData2D to obtain a matrix of double-precision values from the file.
readDoubleData2DTable(Statement, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the columns of the table table.
readDoubleData2DTable(Connection, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the columns of the table table.
readExternal(ObjectInput) - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
readExternal(ObjectInput) - Method in class org.apache.commons.math.ode.sampling.DummyStepInterpolator
Read the instance from an input channel.
readExternal(ObjectInput) - Method in class org.apache.commons.math.ode.sampling.NordsieckStepInterpolator
ReadFile - Static variable in class jhplot.JHPlot
 
readFloat() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readFloat() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readFloat() - Method in class jhplot.math.io.LEDataInputStream
 
readFloat() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readFloat except little endian.
readFloatArray(File, String) - Static method in class jhplot.math.io.BinaryFile
 
readFloatArray() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readFloatArray(InputStream, String) - Static method in class jhplot.math.io.BinaryInputStream
 
readFloatArray() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readFully(byte[]) - Method in class jhplot.math.io.LEDataInputStream
 
readFully(byte[], int, int) - Method in class jhplot.math.io.LEDataInputStream
 
readFully(byte[]) - Method in class jhplot.math.io.LERandomAccessFile
 
readFully(byte[], int, int) - Method in class jhplot.math.io.LERandomAccessFile
 
readGZip(File) - Static method in class jhplot.io.PReader
Read data from a gzipped file (GNU gzip/gunzip commands in linux)
readGZip(URL) - Static method in class jhplot.io.PReader
Read data from URL.
readGZip(String) - Static method in class jhplot.io.PReader
Read data from either URL or file
readGZip(String) - Method in class jhplot.P0D
Read P0D from a GZiped file.
readGZip(File) - Method in class jhplot.P0D
Read PNI from a GZiped file.
readGZip(String) - Method in class jhplot.P0I
Read P0D from a GZiped file.
readGZip(File) - Method in class jhplot.P0I
Read PNI from a GZiped file.
readGZip(String) - Method in class jhplot.P1D
Read P1D from a GZiped file.
readGZip(String) - Method in class jhplot.P2D
Read P2D from a GZiped file.
readGZip(String) - Method in class jhplot.P3D
Read P3D from a GZipped file.
readGZip(String) - Method in class jhplot.PND
Read PND from a GZiped file.
readGZip(File) - Method in class jhplot.PND
Read PND from a GZiped file.
readGZip(String) - Method in class jhplot.PNI
Read PNI from a GZiped file.
readGZip(File) - Method in class jhplot.PNI
Read PNI from a GZiped file.
readInfo() - Static method in class jhplot.JHPlot
 
readInt() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readInt() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readInt() - Method in class jhplot.math.io.LEDataInputStream
 
readInt() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readInt except little endian.
readInt1DArray(File) - Static method in class jhplot.math.io.ASCIIFile
 
readIntArray(File) - Static method in class jhplot.math.io.ASCIIFile
 
readIntArray(File, String) - Static method in class jhplot.math.io.BinaryFile
 
readIntArray() - Method in class jhplot.math.io.BinaryFile
Read a binary File
readIntArray(InputStream, String) - Static method in class jhplot.math.io.BinaryInputStream
 
readIntArray() - Method in class jhplot.math.io.BinaryInputStream
Read a binary File
readIntData(Statement, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into an array of integers.
readIntData(Connection, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into an array of integers.
readIntData(Statement, String, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the column column of the table table.
readIntData(Connection, String, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the column column of the table table.
readIntData(Reader) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
This is equivalent to readDoubleData, for reading integers.
readIntData(URL) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Connects to the URL referred to by the URL object url, and calls readIntData to obtain an array of integers from the resource.
readIntData(File) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
This is equivalent to readDoubleData, for reading integers.
readIntData(String) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
This is equivalent to readDoubleData, for reading integers.
readIntData2D(Statement, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into a rectangular 2D array of integers.
readIntData2D(Connection, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into a rectangular 2D array of integers.
readIntData2D(Reader) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
This is equivalent to readDoubleData2D, for reading integers.
readIntData2D(URL) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Connects to the URL referred to by the URL object url, and calls readDoubleData to obtain a matrix of integers from the resource.
readIntData2D(File) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
This is equivalent to readDoubleData2D, for reading integers.
readIntData2D(String) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
This is equivalent to readDoubleData2D, for reading integers.
readIntData2DTable(Statement, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the columns of the table table.
readIntData2DTable(Connection, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the columns of the table table.
readLine(File, int) - Static method in class jhplot.math.io.ASCIIFile
 
readLine(int) - Method in class jhplot.math.io.ASCIIFile
Read only one line in an ASCII File
readLine() - Method in class jhplot.math.io.LEDataInputStream
 
readLine() - Method in class jhplot.math.io.LERandomAccessFile
 
readLines(File) - Static method in class jhplot.math.io.ASCIIFile
 
readLines() - Method in class jhplot.math.io.ASCIIFile
Read lines of an ASCII File
readList() - Method in class jhplot.io.csv.CSVReader
Reads the entire file into a List with each element being a List of tokens.
readLong() - Method in class jhplot.math.io.LEDataInputStream
 
readLong() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readLong except little endian.
readMatrixInfo() - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads the matrix info for the Matrix Market exchange format.
readMatrixSize(MatrixInfo) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads in the size of a matrix.
readNext() - Method in class jhplot.io.csv.CSVReader
Reads the next line from the buffer and converts to a string array.
readObjectData(Statement, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into an array of objects.
readObjectData(Connection, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into an array of objects.
readObjectData(Statement, String, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the column column of the table table.
readObjectData(Connection, String, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the column column of the table table.
readObjectData2D(Statement, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into a rectangular 2D array of objects.
readObjectData2D(Connection, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Copies the result of the SQL query query into a rectangular 2D array of integers.
readObjectData2DTable(Statement, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the columns of the table table.
readObjectData2DTable(Connection, String) - Static method in class umontreal.iro.lecuyer.util.JDBCManager
Returns the values of the columns of the table table.
ReadOnlyAbstractTuple - Class in hep.aida.ref.tuple
Base class for read only tuples.
ReadOnlyAbstractTuple(String, String) - Constructor for class hep.aida.ref.tuple.ReadOnlyAbstractTuple
 
ReadOnlyAbstractTuple(String, String, String) - Constructor for class hep.aida.ref.tuple.ReadOnlyAbstractTuple
 
ReadOnlyException - Exception in hep.aida.ref
An exception thrown when an attempt is made to modify a readOnly AIDA object.
ReadOnlyException() - Constructor for exception hep.aida.ref.ReadOnlyException
 
ReadOnlyException(IManagedObject) - Constructor for exception hep.aida.ref.ReadOnlyException
 
readPattern(int[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a pattern vector
readPattern(int[], int[]) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads a pattern matrix
readRecord(String) - Method in class jhplot.io.BaseRecordsFile
Reads a record.
readScoresAsRowPerItem() - Method in class flanagan.analysis.Scores
 
readScoresAsRowPerItem(String) - Method in class flanagan.analysis.Scores
 
readScoresAsRowPerPerson() - Method in class flanagan.analysis.Scores
 
readScoresAsRowPerPerson(String) - Method in class flanagan.analysis.Scores
 
readScript(File, HPlot) - Static method in class jhplot.io.JHreader
Read the file.
readSerialized(String) - Method in class jhplot.P0D
Read a P0D object from a serialized file
readSerialized(String) - Method in class jhplot.P0I
Read a P0I object from a serialized file
readSerialized(String) - Method in class jhplot.P1D
Read a P1D object from a serialized file
readSerialized(String) - Method in class jhplot.P2D
Read a P2D object from a serialized file
readSerialized(String) - Method in class jhplot.P3D
Read a P3D object from a serialized file
readSerialized(String) - Method in class jhplot.PND
Read a PND object from a serialized file
readSerialized(String) - Method in class jhplot.PNI
Read a PNI object from a serialized file
readShort() - Method in class jhplot.math.io.LEDataInputStream
 
readShort() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readShort except little endian.
readString1DDouble(String) - Static method in class jhplot.math.io.ArrayString
 
readString1DDouble(String, String, String) - Static method in class jhplot.math.io.ArrayString
 
readString1DInt(String) - Static method in class jhplot.math.io.ArrayString
 
readString1DInt(String, String, String) - Static method in class jhplot.math.io.ArrayString
 
readStringData(Reader) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Reads an array of strings from the reader input.
readStringData(URL) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
Connects to the URL referred to by the URL object url, and calls readStringData to obtain an array of integers from the resource.
readStringData(File) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
This is equivalent to readDoubleData, for reading strings.
readStringData(String) - Static method in class umontreal.iro.lecuyer.util.TextDataReader
This is equivalent to readDoubleData, for reading strings.
readStringDouble(String) - Static method in class jhplot.math.io.ArrayString
 
readStringDouble(String, String, String) - Static method in class jhplot.math.io.ArrayString
 
readStringInt(String) - Static method in class jhplot.math.io.ArrayString
 
readStringInt(String, String, String) - Static method in class jhplot.math.io.ArrayString
 
readUnsignedByte() - Method in class jhplot.math.io.LEDataInputStream
 
readUnsignedByte() - Method in class jhplot.math.io.LERandomAccessFile
 
readUnsignedShort() - Method in class jhplot.math.io.LEDataInputStream
 
readUnsignedShort() - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.readUnsignedShort except little endian.
readUTF() - Method in class jhplot.math.io.LEDataInputStream
 
readUTF(DataInput) - Static method in class jhplot.math.io.LEDataInputStream
 
readUTF() - Method in class jhplot.math.io.LERandomAccessFile
 
readVectorArraySize() - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads in the size of a dense vector.
readVectorCoordinateSize() - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads in the size of a coordinate vector.
readVectorInfo() - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads the vector info for the Matrix Market exchange format.
readVectorSize(VectorInfo) - Method in class cern.colt.matrix.io.MatrixVectorReader
Reads in the size of a vector.
readXML(String) - Static method in class jhplot.io.Serialized
Read an object from a serialized XML file (should be written using writeXML() method).
readZip(String) - Method in class jhplot.P0D
Read one dimensional data from ZIP ASCII file.
readZip(String) - Method in class jhplot.P0I
Read one dimensional data from ZIP ASCII file.
readZip(String) - Method in class jhplot.P1D
Read P1D from a Zipped file.
readZip(String) - Method in class jhplot.P2D
Read P1D from a Zipped file.
readZip(String) - Method in class jhplot.P3D
Read P3D from a Zipped file.
readZip(String) - Method in class jhplot.PND
Read the data from ZIPed external file.
readZip(String) - Method in class jhplot.PNI
Read the data from ZIPed external file.
real() - Method in class jhplot.math.Complex
Real part of this Complex number (the x-coordinate in rectangular coordinates).
RealConvergenceChecker - Interface in org.apache.commons.math.optimization
This interface specifies how to check if an optimization algorithm has converged.
RealDComplexDComplexFunction - Interface in cern.colt.function.tdcomplex
 
RealDComplexFunction - Interface in cern.colt.function.tdcomplex
 
RealFComplexFComplexFunction - Interface in cern.colt.function.tfcomplex
 
RealFComplexFunction - Interface in cern.colt.function.tfcomplex
 
RealMatrix - Interface in org.apache.commons.math.linear
Interface defining a real-valued matrix with basic algebraic operations.
RealMatrixChangingVisitor - Interface in org.apache.commons.math.linear
Interface defining a visitor for matrix entries.
RealMatrixImpl - Class in org.apache.commons.math.linear
Deprecated. as of 2.0 replaced by Array2DRowRealMatrix
RealMatrixImpl() - Constructor for class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Creates a matrix with no data
RealMatrixImpl(int, int) - Constructor for class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Create a new RealMatrix with the supplied row and column dimensions.
RealMatrixImpl(double[][]) - Constructor for class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Create a new RealMatrix using the input array as the underlying data array.
RealMatrixImpl(double[][], boolean) - Constructor for class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Create a new RealMatrix using the input array as the underlying data array.
RealMatrixImpl(double[]) - Constructor for class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Create a new (column) RealMatrix using v as the data for the unique column of the v.length x 1 matrix created.
RealMatrixPreservingVisitor - Interface in org.apache.commons.math.linear
Interface defining a visitor for matrix entries.
RealPointValuePair - Class in org.apache.commons.math.optimization
This class holds a point and the value of an objective function at this point.
RealPointValuePair(double[], double) - Constructor for class org.apache.commons.math.optimization.RealPointValuePair
Build a point/objective function value pair.
RealPointValuePair(double[], double, boolean) - Constructor for class org.apache.commons.math.optimization.RealPointValuePair
Build a point/objective function value pair.
RealTransformer - Interface in org.apache.commons.math.transform
Interface for one-dimensional data sets transformations producing real results.
RealVector - Interface in org.apache.commons.math.linear
Interface defining a real-valued vector with basic algebraic operations.
RealVector.Entry - Class in org.apache.commons.math.linear
Class representing a modifiable entry in the vector.
RealVector.Entry() - Constructor for class org.apache.commons.math.linear.RealVector.Entry
 
RealVectorFormat - Class in org.apache.commons.math.linear
Formats a vector in components list format "{v0; v1; ...; vk-1}".
RealVectorFormat() - Constructor for class org.apache.commons.math.linear.RealVectorFormat
Create an instance with default settings.
RealVectorFormat(NumberFormat) - Constructor for class org.apache.commons.math.linear.RealVectorFormat
Create an instance with a custom number format for components.
RealVectorFormat(String, String, String) - Constructor for class org.apache.commons.math.linear.RealVectorFormat
Create an instance with custom prefix, suffix and separator.
RealVectorFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math.linear.RealVectorFormat
Create an instance with custom prefix, suffix, separator and format for components.
rebin(int) - Method in class jhplot.H1D
Rebin a histogram with constant bin width.
reciprocal() - Method in class org.apache.commons.math.fraction.BigFraction
Return the multiplicative inverse of this fraction.
reciprocal() - Method in class org.apache.commons.math.fraction.Fraction
Return the multiplicative inverse of this fraction.
recordExists(String) - Method in class jhplot.io.BaseRecordsFile
Checks there is a record with the given key.
recordExists(String) - Method in class jhplot.io.RecordsFile
Checks if there is a record belonging to the given key.
RecordHeader - Class in jhplot.io
 
RecordReader - Class in jhplot.io
 
recordsFile - Variable in class jhplot.io.HDataBase
 
recordsFile - Variable in class jhplot.io.HFile
 
recordsFile - Variable in class jhplot.io.HFileXML
 
RecordsFile - Class in jhplot.io
 
RecordsFile(String, int) - Constructor for class jhplot.io.RecordsFile
Creates a new database file.
RecordsFile(String, String) - Constructor for class jhplot.io.RecordsFile
Opens an existing database and initializes the in-memory index.
RecordsFileException - Exception in jhplot.io
 
RecordWriter - Class in jhplot.io
 
RecordWriter(String) - Constructor for class jhplot.io.RecordWriter
 
RECTAN - Static variable in class jhplot.shapes.HShape
 
Rectan - Class in jhplot.shapes
Draw a rectangle using the user or NDC coordinate system
Rectan(double, double, double, double, Stroke, Color) - Constructor for class jhplot.shapes.Rectan
Build a rectangle
Rectan(double, double, double, double) - Constructor for class jhplot.shapes.Rectan
Build a rectangle.
rectangularHyperbola() - Method in class flanagan.analysis.Regression
 
rectangularHyperbolaPlot() - Method in class flanagan.analysis.Regression
 
RedblackTree - Class in umontreal.iro.lecuyer.simevents.eventlist
An implementation of EventList using a red black tree, which is similar to a binary search tree except that every node is colored red or black.
RedblackTree() - Constructor for class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
reduce() - Method in class org.apache.commons.math.fraction.BigFraction
Reduce this BigFraction to its lowest terms.
reducedErrors() - Method in class flanagan.analysis.RankAnalysis
 
reducedErrorsDiagonal() - Method in class flanagan.analysis.RankAnalysis
 
reducedRatiosDiagonal() - Method in class flanagan.analysis.RankAnalysis
 
reducedRowEchelonForm() - Method in class flanagan.math.Matrix
 
reducedValues() - Method in class flanagan.analysis.RankAnalysis
 
reducedValuesDiagonal() - Method in class flanagan.analysis.RankAnalysis
 
RefreshFrame() - Method in class jhplot.HPlot
Refresh all the frames
regIncompleteGamma(double, double) - Static method in class flanagan.analysis.Stat
 
regIncompleteGammaComplementary(double, double) - Static method in class flanagan.analysis.Stat
 
Regression - Class in flanagan.analysis
 
Regression() - Constructor for class flanagan.analysis.Regression
 
Regression(double[][], double[], double[]) - Constructor for class flanagan.analysis.Regression
 
Regression(double[][], double[][], double[][]) - Constructor for class flanagan.analysis.Regression
 
Regression(double[], double[], double[]) - Constructor for class flanagan.analysis.Regression
 
Regression(double[], double[][], double[][]) - Constructor for class flanagan.analysis.Regression
 
Regression(double[][], double[]) - Constructor for class flanagan.analysis.Regression
 
Regression(double[][], double[][]) - Constructor for class flanagan.analysis.Regression
 
Regression(double[], double[]) - Constructor for class flanagan.analysis.Regression
 
Regression(double[], double[][]) - Constructor for class flanagan.analysis.Regression
 
Regression(double[], double, double) - Constructor for class flanagan.analysis.Regression
 
Regression(double[], double) - Constructor for class flanagan.analysis.Regression
 
RegressionDerivativeFunction - Interface in flanagan.analysis
 
RegressionDerivativeFunction2 - Interface in flanagan.analysis
 
RegressionFunction - Interface in flanagan.analysis
 
RegressionFunction2 - Interface in flanagan.analysis
 
regroupCategories(double) - Method in class umontreal.iro.lecuyer.gof.GofStat.OutcomeCategoriesChi2
Regroup categories as explained earlier, so that the expected number of observations in each category is at least minExp.
regularisedBetaFunction(double, double, double) - Static method in class flanagan.analysis.Stat
 
regularisedGammaFunction(double, double) - Static method in class flanagan.analysis.Stat
 
regularizedBeta(double, double, double) - Static method in class jhplot.math.num.special.Beta
Returns the regularized beta function Ix(a, b) (1).
regularizedBeta(double, double, double) - Static method in class org.apache.commons.math.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, double) - Static method in class org.apache.commons.math.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, int) - Static method in class org.apache.commons.math.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBeta(double, double, double, double, int) - Static method in class org.apache.commons.math.special.Beta
Returns the regularized beta function I(x, a, b).
regularizedBetaFunction(double, double, double) - Static method in class flanagan.analysis.Stat
 
regularizedGammaFunction(double, double) - Static method in class flanagan.analysis.Stat
 
regularizedGammaP(double, double) - Static method in class jhplot.math.num.special.Gamma
Returns the regularized gamma function P(a, x) (1).
regularizedGammaP(double, double) - Static method in class org.apache.commons.math.special.Gamma
Returns the regularized gamma function P(a, x).
regularizedGammaP(double, double, double, int) - Static method in class org.apache.commons.math.special.Gamma
Returns the regularized gamma function P(a, x).
regularizedGammaQ(double, double) - Static method in class jhplot.math.num.special.Gamma
Returns the regularized gamma function Q(a, x) = 1 - P(a, x) (1).
regularizedGammaQ(double, double) - Static method in class org.apache.commons.math.special.Gamma
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
regularizedGammaQ(double, double, double, int) - Static method in class org.apache.commons.math.special.Gamma
Returns the regularized gamma function Q(a, x) = 1 - P(a, x).
rehash(int) - Method in class cern.colt.map.tint.QuickOpenIntIntHashMap
Rehashes the contents of the receiver into a new table with a smaller or larger capacity.
reinitialize(double[], boolean) - Method in class org.apache.commons.math.ode.sampling.NordsieckStepInterpolator
Reinitialize the instance.
reinitialize(double, double, double[], Array2DRowRealMatrix) - Method in class org.apache.commons.math.ode.sampling.NordsieckStepInterpolator
Reinitialize the instance.
reinitializeBegin(StepInterpolator) - Method in class org.apache.commons.math.ode.events.EventState
Reinitialize the beginning of the step.
reinstateStats() - Method in class flanagan.analysis.Regression
 
rejection(Function, double, double, double) - Static method in class jhplot.math.Random
Generate a random number from a random variable definied by its density function, using the rejection technic.
rejection(ParseFunction, double, double, double) - Static method in class jhplot.math.Random
Generate a random number from a random variable definied by its density function, using the rejection technic.
Relationship - Enum in org.apache.commons.math.optimization.linear
Types of relationships between two cells in a Solver LinearConstraint.
release(int) - Method in class umontreal.iro.lecuyer.simprocs.Resource
The executing process that invokes this method releases n units of the resource.
reloadCanvas() - Static method in class jhplot.SHPlot
Reload the canvas by removing components
reloadCanvas() - Static method in class jhplot.SHPlot3D
Reload the canvas by removing components
reloadCanvas() - Static method in class jhplot.SHPlotJa
Reload the canvas by removing components
reloadData(String) - Method in class jhplot.bsom.Bsom
 
remainder(Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Returns the IEEE remainder.
remembranceSunday() - Method in class flanagan.math.TimeAndDate
 
remembranceSunday(int) - Method in class flanagan.math.TimeAndDate
 
remove(int) - Method in class cern.colt.list.AbstractList
Removes the element at the specified position from the receiver.
remove(int) - Method in class cern.colt.list.adapter.DoubleListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.adapter.FloatListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.adapter.IntListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.adapter.LongListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.adapter.ObjectListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.tdouble.DoubleListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.tfloat.FloatListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.tint.IntListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.tlong.LongListAdapter
Removes the element at the specified position in this list (optional operation).
remove(int) - Method in class cern.colt.list.tobject.ObjectListAdapter
Removes the element at the specified position in this list (optional operation).
remove(String) - Method in class hep.aida.ref.function.FunctionCatalog
 
remove(String) - Method in class jhplot.io.HDataBase
Remove object from the database using the key
remove(int) - Method in class jhplot.P0D
Remove a value at the specified position.
remove(int) - Method in class jhplot.P0I
Remove a value at the specified position.
remove(int) - Method in class jhplot.PND
Remove a row
remove(int) - Method in class jhplot.PNI
Remove a row
remove() - Method in class org.apache.commons.math.util.MultidimensionalCounter.Iterator
 
remove(int) - Method in class org.apache.commons.math.util.OpenIntToDoubleHashMap
Remove the value associated with a key.
remove(int) - Method in class org.apache.commons.math.util.OpenIntToFieldHashMap
Remove the value associated with a key.
remove(RandomStream) - Method in class umontreal.iro.lecuyer.rng.RandomStreamManager
Removes the given stream from the internal list of this random stream manager.
remove(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
remove(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
remove(Event) - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Removes the event ev from the event list (cancels this event).
remove(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
remove(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
remove(Event) - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
remove(int) - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
 
remove(int) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
remove(Object) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
remove(int) - Method in class umontreal.iro.lecuyer.util.TransformingList
 
removeAll(AbstractBooleanList) - Method in class cern.colt.list.AbstractBooleanList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractByteList) - Method in class cern.colt.list.AbstractByteList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractCharList) - Method in class cern.colt.list.AbstractCharList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractDoubleList) - Method in class cern.colt.list.AbstractDoubleList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractFloatList) - Method in class cern.colt.list.AbstractFloatList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractIntList) - Method in class cern.colt.list.AbstractIntList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractLongList) - Method in class cern.colt.list.AbstractLongList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractShortList) - Method in class cern.colt.list.AbstractShortList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractBooleanList) - Method in class cern.colt.list.BooleanArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractByteList) - Method in class cern.colt.list.ByteArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractCharList) - Method in class cern.colt.list.CharArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractDoubleList) - Method in class cern.colt.list.DoubleArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractFloatList) - Method in class cern.colt.list.FloatArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractIntList) - Method in class cern.colt.list.IntArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractLongList) - Method in class cern.colt.list.LongArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(ObjectArrayList, boolean) - Method in class cern.colt.list.ObjectArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractShortList) - Method in class cern.colt.list.ShortArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractBooleanList) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractBooleanList) - Method in class cern.colt.list.tboolean.BooleanArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractByteList) - Method in class cern.colt.list.tbyte.AbstractByteList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractByteList) - Method in class cern.colt.list.tbyte.ByteArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractCharList) - Method in class cern.colt.list.tchar.AbstractCharList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractCharList) - Method in class cern.colt.list.tchar.CharArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractDoubleList) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractDoubleList) - Method in class cern.colt.list.tdouble.DoubleArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractFloatList) - Method in class cern.colt.list.tfloat.AbstractFloatList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractFloatList) - Method in class cern.colt.list.tfloat.FloatArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractIntList) - Method in class cern.colt.list.tint.AbstractIntList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractIntList) - Method in class cern.colt.list.tint.IntArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractLongList) - Method in class cern.colt.list.tlong.AbstractLongList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractLongList) - Method in class cern.colt.list.tlong.LongArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(ObjectArrayList, boolean) - Method in class cern.colt.list.tobject.ObjectArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractShortList) - Method in class cern.colt.list.tshort.AbstractShortList
Removes from the receiver all elements that are contained in the specified list.
removeAll(AbstractShortList) - Method in class cern.colt.list.tshort.ShortArrayList
Removes from the receiver all elements that are contained in the specified list.
removeAll(Collection<?>) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
removeAllFunctions() - Method in class hep.aida.ref.function.SumOfFunctions
 
removeAllListeners() - Method in class hep.aida.ref.event.AIDAObservable
 
removeAllListeners() - Method in interface hep.aida.ref.event.IsObservable
 
removeAllOf(DoubleArrayList) - Method in class cern.hep.aida.bin.DynamicBin1D
Removes from the receiver all elements that are contained in the specified list.
removeAllOf(DoubleArrayList) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Removes from the receiver all elements that are contained in the specified list.
removeAllOf(FloatArrayList) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Removes from the receiver all elements that are contained in the specified list.
removeArrayOfObservationListener(ArrayOfObservationListener) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Removes the observation listener l from the list of observers of this list of statistical probes.
removeAxes() - Method in class jhplot.HPlot
Remove X and Y axes, ticks, axis labels on the current plot.
removeAxes() - Method in class jhplot.HPlotJa
remove X and Y axes, tics, axis labels on the current plot.
removeBounds() - Method in class hep.aida.ref.fitter.FitParameterSettings
 
removeConstraints() - Method in class flanagan.analysis.Regression
 
removeConstraints() - Method in class flanagan.math.Maximisation
 
removeConstraints() - Method in class flanagan.math.Minimisation
 
removeContentFromBin(int[], int, double, double[], double[]) - Method in interface hep.aida.ref.dataset.binner.Binner
Remove a set of entries from a bin.
removeContentFromBin(int[], int, double, double[], double[]) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
 
removeContentFromBin(int[], int, double, double[], double[]) - Method in class hep.aida.ref.dataset.binner.EfficiencyBinner
 
removeData(double, double) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Removes the observation (x,y) from the regression data set.
removeData(double[][]) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Removes observations represented by the elements in data.
removeDuplicates() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Removes (sums) duplicate entries (if any}
removeDuplicates() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Removes (sums) duplicate entries (if any}
removeEntries(double[], double[], double, double, int) - Method in class hep.aida.ref.dataset.DataStatistics
Remove the information corresponding to a set of weighted entries.
removeEntries(double[], double[], int) - Method in class hep.aida.ref.dataset.DataStatistics
Remove the information corresponding to a set of weighted entries.
removeEntry(double[], double) - Method in class hep.aida.ref.dataset.DataStatistics
Remove a weighted entry from this DataSetStatistics.
removeEntry(double[]) - Method in class hep.aida.ref.dataset.DataStatistics
Remove an entry from this DataSetStatistics with unit weight.
removeFileNumbering() - Method in class flanagan.analysis.Scores
 
removeFirst() - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
removeFirst() - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
removeFirst() - Method in interface umontreal.iro.lecuyer.simevents.eventlist.EventList
Removes the first event from the event list (to cancel or execute this event).
removeFirst() - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
removeFirst() - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
removeFirst() - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
removeFirst() - Method in class umontreal.iro.lecuyer.simevents.LinkedListStat
 
removeFromTo(int, int) - Method in class cern.colt.list.AbstractBooleanList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractByteList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractCharList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractDoubleList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractFloatList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractIntList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractLongList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.AbstractShortList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.DistinctNumberList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.tint.AbstractIntList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.tlong.DistinctNumberList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFromTo(int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Removes from the receiver all elements whose index is between from, inclusive and to, inclusive.
removeFunction(IFunction) - Method in class hep.aida.ref.function.SumOfFunctions
 
removeFunctionListener(FunctionListener) - Method in class hep.aida.ref.function.AbstractIFunction
 
removeFunctionListener(FunctionListener) - Method in class hep.aida.ref.function.BaseModelFunction
 
removeFunctionListener(FunctionListener) - Method in interface hep.aida.ref.function.FunctionDispatcher
 
removeGraph() - Method in class jhplot.HPlot
Remove all components from the JHPlot frame.
removeItem(String) - Method in class hep.aida.ref.Annotation
Remove the item indicated by a given key.
removeKey(double) - Method in class cern.colt.map.AbstractDoubleIntMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.AbstractIntDoubleMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.AbstractIntIntMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.AbstractIntObjectMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.AbstractLongObjectMap
Removes the given key with its associated element from the receiver, if present.
removeKey(double) - Method in class cern.colt.map.OpenDoubleIntHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.OpenIntDoubleHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.OpenIntIntHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.OpenIntObjectHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.OpenLongObjectHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(double) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Removes the given key with its associated element from the receiver, if present.
removeKey(double) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Removes the given key with its associated element from the receiver, if present.
removeKey(double) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(double) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(float) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Removes the given key with its associated element from the receiver, if present.
removeKey(float) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Removes the given key with its associated element from the receiver, if present.
removeKey(float) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(float) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.tint.AbstractIntIntMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Removes the given key with its associated element from the receiver, if present.
removeKey(int) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Removes the given key with its associated element from the receiver, if present.
removeKey(long) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Removes the given key with its associated element from the receiver, if present.
removeLabel(int) - Method in class jhplot.HPlot
remove i-th HLabel or HMLabel on the current plot
removeLabels() - Method in class jhplot.HPlot
remove HLabels and HMLabels on the current plot
removeLabelsAll() - Method in class jhplot.HPlot
remove all Labels on all plots.
removeLast() - Method in class umontreal.iro.lecuyer.simevents.LinkedListStat
 
removeListener(AIDAListener) - Method in class hep.aida.ref.event.AIDAObservable
 
removeListener(AIDAListener) - Method in interface hep.aida.ref.event.IsObservable
 
removeMostRecentValue() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Removes the most recent value from the dataset.
removeNaNs(double[], double[]) - Static method in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Removes any point (NaN, y) or (x, NaN) from x and y, and returns a 2D array containing the filtered points.
removeObject(int, int, int) - Method in class jhplot.HPlotJa
Remove a particular object
removeObservationListener(ObservationListener) - Method in class umontreal.iro.lecuyer.stat.StatProbe
Removes the observation listener l from the list of observers of this statistical probe.
removePoint(int) - Method in class hep.aida.ref.histogram.DataPointSet
 
removePrimitives() - Method in class jhplot.HPlot
remove 2D java primitives on the current plot
removePrimitives(int) - Method in class jhplot.HPlot
remove i-th 2D java primitives on the current plot
removePrimitivesAll() - Method in class jhplot.HPlot
remove all 2D java primitives
removeTransformer(Class<?>) - Method in class org.apache.commons.math.util.TransformerMap
Removes a Class to Transformer Mapping in the Map.
removeWindow() - Method in class flanagan.math.FourierTransform
 
removeZeroes() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Removes zero entries (if any)
removeZeroes() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Removes zero entries (if any)
renameLegend(int, String) - Method in class jhplot.SPlot
Rename a legend.
renyiEntropy(double) - Method in class flanagan.analysis.Stat
 
renyiEntropy(double[], double) - Static method in class flanagan.analysis.Stat
 
renyiEntropyBit(double) - Method in class flanagan.analysis.Stat
 
renyiEntropyBit(double[], double) - Static method in class flanagan.analysis.Stat
 
renyiEntropyDit(double) - Method in class flanagan.analysis.Stat
 
renyiEntropyDit(double[], double) - Static method in class flanagan.analysis.Stat
 
renyiEntropyNat(double) - Method in class flanagan.analysis.Stat
 
renyiEntropyNat(double[], double) - Static method in class flanagan.analysis.Stat
 
repeat(DoubleMatrix1D, int) - Method in class cern.colt.matrix.DoubleFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(DoubleMatrix2D, int, int) - Method in class cern.colt.matrix.DoubleFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
repeat(ObjectMatrix1D, int) - Method in class cern.colt.matrix.ObjectFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(ObjectMatrix2D, int, int) - Method in class cern.colt.matrix.ObjectFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
repeat(DComplexMatrix1D, int) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(DComplexMatrix2D, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
repeat(DoubleMatrix1D, int) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(DoubleMatrix2D, int, int) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
repeat(FComplexMatrix1D, int) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(FComplexMatrix2D, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
repeat(FloatMatrix1D, int) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(FloatMatrix2D, int, int) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
repeat(IntMatrix1D, int) - Method in class cern.colt.matrix.tint.IntFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(IntMatrix2D, int, int) - Method in class cern.colt.matrix.tint.IntFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
repeat(LongMatrix1D, int) - Method in class cern.colt.matrix.tlong.LongFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(LongMatrix2D, int, int) - Method in class cern.colt.matrix.tlong.LongFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
repeat(ObjectMatrix1D, int) - Method in class cern.colt.matrix.tobject.ObjectFactory1D
C = A||A||..||A; Constructs a new matrix which is concatenated repeat times.
repeat(ObjectMatrix2D, int, int) - Method in class cern.colt.matrix.tobject.ObjectFactory2D
C = A||A||..||A; Constructs a new matrix which is duplicated both along the row and column dimension.
replace(int, double, double, double, double, double, double, double, double, double, double) - Method in class jhplot.P1D
replaces the ith value of a plot-point pair (x,y).
replaceBoxWith(int, int, int, int, BitMatrix, int, int) - Method in class cern.colt.bitvector.BitMatrix
Replaces a box of the receiver with the contents of another matrix's box.
replaceBoxWith(int, int, int, int, boolean) - Method in class cern.colt.bitvector.BitMatrix
Sets the bits in the given box to the state specified by value.
replaceBoxWith(int, int, int, int, BitMatrix, int, int) - Method in class cern.colt.matrix.tbit.BitMatrix
Replaces a box of the receiver with the contents of another matrix's box.
replaceBoxWith(int, int, int, int, boolean) - Method in class cern.colt.matrix.tbit.BitMatrix
Sets the bits in the given box to the state specified by value.
replaceFromToWith(int, int, BitVector, int) - Method in class cern.colt.bitvector.BitVector
Replaces the bits of the receiver in the given range with the bits of another bit vector.
replaceFromToWith(int, int, boolean) - Method in class cern.colt.bitvector.BitVector
Sets the bits in the given range to the state specified by value.
replaceFromToWith(int, int, BitVector, int) - Method in class cern.colt.matrix.tbit.BitVector
Replaces the bits of the receiver in the given range with the bits of another bit vector.
replaceFromToWith(int, int, boolean) - Method in class cern.colt.matrix.tbit.BitVector
Sets the bits in the given range to the state specified by value .
replaceFromToWithFrom(int, int, AbstractBooleanList, int) - Method in class cern.colt.list.AbstractBooleanList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractByteList, int) - Method in class cern.colt.list.AbstractByteList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractCharList, int) - Method in class cern.colt.list.AbstractCharList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractDoubleList, int) - Method in class cern.colt.list.AbstractDoubleList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractFloatList, int) - Method in class cern.colt.list.AbstractFloatList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractIntList, int) - Method in class cern.colt.list.AbstractIntList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractLongList, int) - Method in class cern.colt.list.AbstractLongList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractShortList, int) - Method in class cern.colt.list.AbstractShortList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractBooleanList, int) - Method in class cern.colt.list.BooleanArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractByteList, int) - Method in class cern.colt.list.ByteArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractCharList, int) - Method in class cern.colt.list.CharArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractDoubleList, int) - Method in class cern.colt.list.DoubleArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractFloatList, int) - Method in class cern.colt.list.FloatArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractIntList, int) - Method in class cern.colt.list.IntArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractLongList, int) - Method in class cern.colt.list.LongArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, ObjectArrayList, int) - Method in class cern.colt.list.ObjectArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractShortList, int) - Method in class cern.colt.list.ShortArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractBooleanList, int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractBooleanList, int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractByteList, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractByteList, int) - Method in class cern.colt.list.tbyte.ByteArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractCharList, int) - Method in class cern.colt.list.tchar.AbstractCharList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractCharList, int) - Method in class cern.colt.list.tchar.CharArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractDoubleList, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractDoubleList, int) - Method in class cern.colt.list.tdouble.DoubleArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractFloatList, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractFloatList, int) - Method in class cern.colt.list.tfloat.FloatArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractIntList, int) - Method in class cern.colt.list.tint.AbstractIntList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractIntList, int) - Method in class cern.colt.list.tint.IntArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractLongList, int) - Method in class cern.colt.list.tlong.AbstractLongList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractLongList, int) - Method in class cern.colt.list.tlong.LongArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, ObjectArrayList, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractShortList, int) - Method in class cern.colt.list.tshort.AbstractShortList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFrom(int, int, AbstractShortList, int) - Method in class cern.colt.list.tshort.ShortArrayList
Replaces a number of elements in the receiver with the same number of elements of another list.
replaceFromToWithFromTo(int, int, AbstractBooleanList, int, int) - Method in class cern.colt.list.AbstractBooleanList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractByteList, int, int) - Method in class cern.colt.list.AbstractByteList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractCharList, int, int) - Method in class cern.colt.list.AbstractCharList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractDoubleList, int, int) - Method in class cern.colt.list.AbstractDoubleList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractFloatList, int, int) - Method in class cern.colt.list.AbstractFloatList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractIntList, int, int) - Method in class cern.colt.list.AbstractIntList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractLongList, int, int) - Method in class cern.colt.list.AbstractLongList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractShortList, int, int) - Method in class cern.colt.list.AbstractShortList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, ObjectArrayList, int, int) - Method in class cern.colt.list.ObjectArrayList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractBooleanList, int, int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractByteList, int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractCharList, int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractDoubleList, int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractFloatList, int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractIntList, int, int) - Method in class cern.colt.list.tint.AbstractIntList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractLongList, int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, ObjectArrayList, int, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromToWithFromTo(int, int, AbstractShortList, int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Replaces the part between from (inclusive) and to (inclusive) with the other list's part between otherFrom and otherTo.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractBooleanList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractByteList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractCharList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractDoubleList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractFloatList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractIntList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractLongList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.AbstractShortList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.ObjectArrayList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.tbyte.AbstractByteList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.tchar.AbstractCharList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.tfloat.AbstractFloatList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.tint.AbstractIntList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.tlong.AbstractLongList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.tobject.ObjectArrayList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceFromWith(int, Collection) - Method in class cern.colt.list.tshort.AbstractShortList
Replaces the part of the receiver starting at from (inclusive) with all the elements of the specified collection.
replaceMostRecentValue(double) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Replaces the most recently stored value with the given value.
REPLAY_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Replay data from valuesFilePath.
report() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
 
report() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
Returns a string containing a statistical report on the list, provided that setStatCollecting (true) has been called before for this list.
report() - Method in class umontreal.iro.lecuyer.simprocs.Bin
Returns a string containing a complete statistical report on this bin.
report() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Returns a string containing a complete statistical report on this resource.
report() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Formats a report for each probe in the list of statistical probes.
report() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Returns a string containing a report for this statistical collector.
report(String, StatProbe[]) - Static method in class umontreal.iro.lecuyer.stat.StatProbe
Formats short reports for each statistical probe in the array probes while aligning the probes' names.
report(String, Iterable<? extends StatProbe>) - Static method in class umontreal.iro.lecuyer.stat.StatProbe
Equivalent to report, except that probes is an Iterable object instead of an array.
report() - Method in class umontreal.iro.lecuyer.stat.Tally
Returns a formatted string that contains a report on this probe.
report(double, int) - Method in class umontreal.iro.lecuyer.stat.Tally
Returns a formatted string that contains a report on this probe with a confidence interval level level using d fractional decimal digits.
reportAndCIStudent(double, int) - Method in class umontreal.iro.lecuyer.stat.Tally
Returns a formatted string that contains a report on this probe (as in report), followed by a confidence interval (as in formatCIStudent), using d fractional decimal digits.
reportAndCIStudent(double) - Method in class umontreal.iro.lecuyer.stat.Tally
Same as reportAndCIStudent (level, 3).
reportAndConfidenceIntervalStudent(double, int) - Method in class umontreal.iro.lecuyer.stat.Tally
Deprecated. 
reportAndConfidenceIntervalStudent(double) - Method in class umontreal.iro.lecuyer.stat.Tally
Deprecated. 
request(int) - Method in class umontreal.iro.lecuyer.simprocs.Resource
The executing process invoking this method requests for n units of this resource.
requiresDenseOutput() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Determines whether this handler needs dense output.
requiresDenseOutput() - Method in interface org.apache.commons.math.ode.jacobians.StepHandlerWithJacobians
Deprecated. Determines whether this handler needs dense output.
requiresDenseOutput() - Method in class org.apache.commons.math.ode.sampling.DummyStepHandler
Determines whether this handler needs dense output.
requiresDenseOutput() - Method in interface org.apache.commons.math.ode.sampling.StepHandler
Determines whether this handler needs dense output.
requiresDenseOutput() - Method in class org.apache.commons.math.ode.sampling.StepNormalizer
Determines whether this handler needs dense output.
rescale(int) - Method in class jhplot.PND
Rescale the column vectors.
rescale(double[][]) - Method in class jhplot.PND
This is an inverse operation to rescale(type) function.
rescale(double) - Method in class org.apache.commons.math.ode.sampling.NordsieckStepInterpolator
Rescale the instance.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaArcObject
Rescales this JaArcObject by the scale factor scale.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaAxes
Rescales this JaAxes by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaBlob
Rescales this JaBlob by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaBox
Rescales this Label by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaKey
Rescales this label by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaLatexText
Rescales this JaxoText by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaLineObject
Rescales this JaxoLine by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaLoopObject
Rescales this JaxoLoop by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaObject
Abstract class to rescale this JaObject by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaText
Rescales this label by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaTextBox
Rescales this Label by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaVertex
Rescales this JaVertex by the scale factor scale, keeping the point (orx, ory) fixed.
rescaleObject(int, int, float) - Method in class jhplot.jadraw.JaVertexT5
Rescales this JaVertex by the scale factor scale, keeping the point (orx, ory) fixed.
reschedule(double) - Method in class umontreal.iro.lecuyer.simevents.Event
Cancels this event and reschedules it to happen in delay time units.
reschedule(double) - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
If the process is in the DELAYED state, removes it from the event list and reschedules it in delay units of time.
reSeed(long) - Method in class org.apache.commons.math.random.RandomDataImpl
Reseeds the random number generator with the supplied seed.
reSeed() - Method in class org.apache.commons.math.random.RandomDataImpl
Reseeds the random number generator with the current time in milliseconds.
reseedRandomGenerator(long) - Method in class org.apache.commons.math.distribution.AbstractContinuousDistribution
Reseeds the random generator used to generate samples.
reseedRandomGenerator(long) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
Reseeds the random generator used to generate samples.
reSeedSecure() - Method in class org.apache.commons.math.random.RandomDataImpl
Reseeds the secure random number generator with the current time in milliseconds.
reSeedSecure(long) - Method in class org.apache.commons.math.random.RandomDataImpl
Reseeds the secure random number generator with the supplied seed.
reset() - Method in class cern.colt.Timer
Resets the timer.
reset() - Method in class cern.hep.aida.ref.Histogram1D
 
reset() - Method in class cern.hep.aida.ref.Histogram2D
 
reset() - Method in class cern.hep.aida.ref.Histogram3D
 
reset(double, double) - Method in class flanagan.analysis.ErrorProp
 
reset() - Method in class hep.aida.ref.Annotation
Reset the contents of the Annotation.
reset() - Method in interface hep.aida.ref.dataset.binner.Binner
Reset the content of the Binner.
reset() - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Reset the content of the Binner.
reset() - Method in class hep.aida.ref.dataset.DataStatistics
Reset all the statistics quantities to zero.
reset() - Method in class hep.aida.ref.fitter.fitdata.FitData
 
reset() - Method in class hep.aida.ref.fitter.FitParameterSettings
 
reset() - Method in class hep.aida.ref.histogram.AbstractBaseHistogram
Reset the histogram; as if just created.
reset() - Method in class hep.aida.ref.histogram.Cloud
Reset the histogram; as if just created.
reset() - Method in class hep.aida.ref.histogram.Cloud1D
 
reset() - Method in class hep.aida.ref.histogram.Cloud2D
 
reset() - Method in class hep.aida.ref.histogram.Cloud3D
 
reset() - Method in class hep.aida.ref.histogram.Histogram
Reset the Histogram.
reset() - Method in class hep.aida.ref.histogram.Histogram1D
Reset the Histogram.
reset() - Method in class hep.aida.ref.histogram.Histogram2D
Reset the Histogram.
reset() - Method in class hep.aida.ref.histogram.Histogram3D
Reset the Histogram.
reset() - Method in class hep.aida.ref.histogram.Profile1D
 
reset() - Method in class hep.aida.ref.histogram.Profile2D
 
reset() - Method in class hep.aida.ref.tuple.AbstractTuple
 
reset() - Method in class hep.aida.ref.tuple.ReadOnlyAbstractTuple
 
reset() - Method in class hep.aida.ref.tuple.Tuple
 
reset() - Method in class hep.aida.ref.tuple.TupleColumn
 
reset() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
reset() - Method in interface hep.aida.tdouble.DoubleIHistogram
Reset contents; as if just constructed.
reset() - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
reset() - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
reset() - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
reset() - Method in interface hep.aida.tfloat.FloatIHistogram
Reset contents; as if just constructed.
reset() - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
reset() - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
reset() - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
reset() - Method in class jhplot.HNeuralNet
Reset the weight matrix and the thresholds.
reset(double, double) - Method in class jhplot.math.ValueErr
Set value and errors to 0
reset() - Method in class jhplot.stat.LinReg
reset data to 0
reset() - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Reset the step handler.
reset(double, double[]) - Method in class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Let the event handlers reset the state if they want.
reset(double, double[]) - Method in class org.apache.commons.math.ode.events.EventState
Let the event handler reset the state if it wants.
reset() - Method in interface org.apache.commons.math.ode.jacobians.StepHandlerWithJacobians
Deprecated. Reset the step handler.
reset() - Method in class org.apache.commons.math.ode.sampling.DummyStepHandler
Reset the step handler.
reset() - Method in interface org.apache.commons.math.ode.sampling.StepHandler
Reset the step handler.
reset() - Method in class org.apache.commons.math.ode.sampling.StepNormalizer
Reset the step handler.
RESET_DERIVATIVES - Static variable in interface org.apache.commons.math.ode.events.EventHandler
Reset derivatives indicator.
RESET_DERIVATIVES - Static variable in interface org.apache.commons.math.ode.jacobians.EventHandlerWithJacobians
Deprecated. Reset derivatives indicator.
RESET_STATE - Static variable in interface org.apache.commons.math.ode.events.EventHandler
Reset state indicator.
RESET_STATE - Static variable in interface org.apache.commons.math.ode.jacobians.EventHandlerWithJacobians
Deprecated. Reset state indicator.
resetAbsoluteAccuracy() - Method in interface org.apache.commons.math.ConvergingAlgorithm
Deprecated. Reset the absolute accuracy to the default.
resetAbsoluteAccuracy() - Method in class org.apache.commons.math.ConvergingAlgorithmImpl
Deprecated. Reset the absolute accuracy to the default.
resetAbsoluteAccuracy() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Reset the absolute accuracy to the default.
resetAxes() - Method in class jhplot.SPlot
Reset the X and Y axes to the ranges that were first specified using setXRange() and setYRange().
resetBin(int[]) - Method in interface hep.aida.ref.dataset.binner.Binner
Reset the content of a bin.
resetBin(int[]) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Reset the content of a bin.
resetCFmaxIter(int) - Static method in class flanagan.analysis.Regression
 
resetCFmaxIter(int) - Static method in class flanagan.analysis.Stat
 
resetCFtolerance(double) - Static method in class flanagan.analysis.Regression
 
resetCFtolerance(double) - Static method in class flanagan.analysis.Stat
 
resetConstraints() - Method in class hep.aida.ref.fitter.Fitter
 
resetCurCoordIndex() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
resetCurCoordIndex() - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Equivalent to setCurCoordIndex (0).
resetCurCycle(int) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
resetCurCycle(int) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSetBase2.CycleBasedPointSetBase2Iterator
 
resetCurPointIndex() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
resetCurPointIndex() - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Equivalent to setCurPointIndex (0).
resetData(double[], double[], double[][]) - Method in class flanagan.interpolation.BiCubicSpline
 
resetData(double[], double[]) - Method in class flanagan.interpolation.CubicSpline
 
resetData(double[], double[]) - Method in class flanagan.interpolation.CubicSplineFast
 
resetData(double[], double[]) - Method in class flanagan.interpolation.CubicSplineShort
 
resetData(double[], double[], double[], double[][][]) - Method in class flanagan.interpolation.TriCubicSpline
 
resetDelta(double) - Method in class flanagan.analysis.ProbabilityPlot
 
resetFunctionValueAccuracy() - Method in interface org.apache.commons.math.analysis.solvers.UnivariateRealSolver
Reset the actual function accuracy to the default.
resetFunctionValueAccuracy() - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverImpl
Deprecated. Reset the actual function accuracy to the default.
resetGeneratorMatrices() - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Restores the original generator matrices.
resetLUzero(double) - Method in class flanagan.math.Matrix
 
resetMargins() - Method in class jhplot.GHPanel
Reset all margins to the default values.
resetMaximalIterationCount() - Method in interface org.apache.commons.math.ConvergingAlgorithm
Deprecated. Reset the upper limit for the number of iterations to the default.
resetMaximalIterationCount() - Method in class org.apache.commons.math.ConvergingAlgorithmImpl
Deprecated. Reset the upper limit for the number of iterations to the default.
resetMaximalIterationCount() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Reset the upper limit for the number of iterations to the default.
resetMinimalIterationCount() - Method in interface org.apache.commons.math.analysis.integration.UnivariateRealIntegrator
Reset the lower limit for the number of iterations to the default.
resetMinimalIterationCount() - Method in class org.apache.commons.math.analysis.integration.UnivariateRealIntegratorImpl
Reset the lower limit for the number of iterations to the default.
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.AntitheticStream
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.BakerTransformedStream
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.F2NL607
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.GenF2w32
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.LFSR113
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.LFSR258
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.MRG31k3p
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.MRG32k3a
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.MRG32k3aL
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.MT19937
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated.  
resetNextSubstream() - Method in interface umontreal.iro.lecuyer.rng.RandomStream
Reinitializes the stream to the beginning of its next substream: Ng is computed, and Cg and Bg are set to Ng.
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.RandomStreamManager
Forwards to the resetNextSubstream methods of all streams in the list.
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.RandRijndael
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.TruncatedRandomStream
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.WELL1024
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.WELL512
 
resetNextSubstream() - Method in class umontreal.iro.lecuyer.rng.WELL607
 
resetNstepsMultiplier(int) - Static method in class flanagan.integration.RungeKutta
 
resetParameterSettings() - Method in class hep.aida.ref.fitter.Fitter
 
resetRelativeAccuracy() - Method in interface org.apache.commons.math.ConvergingAlgorithm
Deprecated. Reset the relative accuracy to the default.
resetRelativeAccuracy() - Method in class org.apache.commons.math.ConvergingAlgorithmImpl
Deprecated. Reset the relative accuracy to the default.
resetRelativeAccuracy() - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Reset the relative accuracy to the default.
resetReplayFile() - Method in class org.apache.commons.math.random.ValueServer
Resets REPLAY_MODE file pointer to the beginning of the valuesFileURL.
resetRiskNeutralCorrection(double) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Changes the value of ωRN.
resetRow() - Method in class hep.aida.ref.tuple.AbstractTuple
 
resetRow() - Method in class hep.aida.ref.tuple.ReadOnlyAbstractTuple
 
resetRow() - Method in class hep.aida.ref.tuple.Tuple
 
resetRow() - Method in class hep.aida.ref.tuple.TupleColumn
 
resetRow() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
resetRows(int) - Method in class hep.aida.ref.tuple.TupleColumn
Clears the values on the stack.
resetRows(int) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
resetStartProcess() - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionBridge
 
resetStartProcess() - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessBridge
 
resetStartProcess() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
Same as in StochasticProcess, but also invokes resetStartProcess for the underlying BrownianMotion object.
resetStartProcess() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Resets the step counter of the geometric process and the underlying Lévy process to the start value.
resetStartProcess() - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
Resets the GeometricaVarianceGammaProcess, but also applies the resetStartProcess method to the VarianceGammaProcess object used to generate this process.
resetStartProcess() - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessBridge
 
resetStartProcess() - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Resets the observation counter to its initial value j = 0, so that the current observation X(tj) becomes X(t0).
resetStartProcess() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Resets the observation index and counter to 0 and applies the resetStartProcess method to the BrownianMotion and the GammaProcess objects used to generate this process.
resetStartProcess() - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
Sets the observation times on the VarianceGammaProcessDiff as usual, but also applies the resetStartProcess method to the two GammaProcess objects used to generate this process.
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.AntitheticStream
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.BakerTransformedStream
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.F2NL607
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.GenF2w32
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.LFSR113
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.LFSR258
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.MRG31k3p
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.MRG32k3a
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.MRG32k3aL
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.MT19937
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated.  
resetStartStream() - Method in interface umontreal.iro.lecuyer.rng.RandomStream
Reinitializes the stream to its initial state Ig: Cg and Bg are set to Ig.
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.RandomStreamManager
Forwards to the resetStartStream methods of all streams in the list.
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.RandRijndael
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.TruncatedRandomStream
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.WELL1024
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.WELL512
 
resetStartStream() - Method in class umontreal.iro.lecuyer.rng.WELL607
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.AntitheticStream
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.BakerTransformedStream
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.F2NL607
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.GenF2w32
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.LFSR113
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.LFSR258
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.MRG31k3p
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.MRG32k3a
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.MRG32k3aL
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.MT19937
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated.  
resetStartSubstream() - Method in interface umontreal.iro.lecuyer.rng.RandomStream
Reinitializes the stream to the beginning of its current substream: Cg is set to Bg.
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.RandomStreamManager
Forwards to the resetStartSubstream methods of all streams in the list.
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.RandRijndael
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.TruncatedRandomStream
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.WELL1024
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.WELL512
 
resetStartSubstream() - Method in class umontreal.iro.lecuyer.rng.WELL607
 
resetState(double, double[]) - Method in interface org.apache.commons.math.ode.events.EventHandler
Reset the state prior to continue the integration.
resetState(double, double[], double[][], double[][]) - Method in interface org.apache.commons.math.ode.jacobians.EventHandlerWithJacobians
Deprecated. Reset the state prior to continue the integration.
resetStyle() - Method in class jhplot.HPlot
Resets the current plot settings to default values.
resetStyleAll() - Method in class jhplot.HPlot
Resets all plot settings to default values.
resetToNextPoint() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
resetToNextPoint() - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Increases the current point index by 1 and returns its new value.
resetUnitNumber(int) - Method in class jhplot.bsom.BsomDemo
 
reshape(int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns new DoubleMatrix2D of size rows x columns whose elements are taken column-wise from this matrix.
reshape(int, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns new DoubleMatrix3D of size slices x rows x columns, whose elements are taken column-wise from this matrix.
reshape(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns new DoubleMatrix2D of size rows x columns whose elements are taken column-wise from this matrix.
reshape(int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns new DoubleMatrix3D of size slices x rows x columns, whose elements are taken column-wise from this matrix.
reshape(int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns new FloatMatrix2D of size rows x columns whose elements are taken column-wise from this matrix.
reshape(int, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns new FloatMatrix3D of size slices x rows x columns, whose elements are taken column-wise from this matrix.
reshape(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns new FloatMatrix2D of size rows x columns whose elements are taken column-wise from this matrix.
reshape(int, int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns new FloatMatrix3D of size slices x rows x columns, whose elements are taken column-wise from this matrix.
reshape(int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
 
reshape(IntMatrix1D, int, int) - Method in class cern.colt.matrix.tint.IntFactory2D
 
reshape(int, int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns new IntMatrix2D of size rows x columns whose elements are taken column-wise from this matrix.
reshape(int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns new IntMatrix3D of size slices x rows x columns, whose elements are taken column-wise from this matrix.
reshape(int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
 
reshape(LongMatrix1D, int, int) - Method in class cern.colt.matrix.tlong.LongFactory2D
 
reshape(int, int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns new LongMatrix2D of size rows x columns whose elements are taken column-wise from this matrix.
reshape(int, int, int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns new LongMatrix3D of size slices x rows x columns, whose elements are taken column-wise from this matrix.
reshape(int, int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
 
reshape(int, int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
 
reshape(int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Returns new ObjectMatrix2D of size rows x columns whose elements are taken column-wise from this matrix.
reshape(int, int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Returns new ObjectMatrix3D of size slices x rows x columns, whose elements are taken column-wise from this matrix.
reshape(int, int, int, int) - Method in class jhplot.v3d.Canvas3d
 
residual() - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
residual() - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Returns current residual
residual() - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
residual() - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Returns current residual
ResizableDoubleArray - Class in org.apache.commons.math.util
A variable length DoubleArray implementation that automatically handles expanding and contracting its internal storage array as elements are added and removed.
ResizableDoubleArray() - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray with default properties.
ResizableDoubleArray(int) - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray with the specified initial capacity.
ResizableDoubleArray(double[]) - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray from an existing double[] with the initial capacity and numElements corresponding to the size of the supplied double[] array.
ResizableDoubleArray(int, float) - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray with the specified initial capacity and expansion factor.
ResizableDoubleArray(int, float, float) - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray with the specified initialCapacity, expansionFactor, and contractionCriteria.
ResizableDoubleArray(int, float, float, int) - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Create a ResizableArray with the specified properties.
ResizableDoubleArray(ResizableDoubleArray) - Constructor for class org.apache.commons.math.util.ResizableDoubleArray
Copy constructor.
RESIZE - Static variable in class jhplot.jadraw.JaObject
An integer that indicates the current edit mode RESIZE.
resize(double[][], int, int) - Static method in class jhplot.math.DoubleArray
Generate a resized copy of a matrix
Resource - Class in umontreal.iro.lecuyer.simprocs
Objects of this class are resources having limited capacity, and which can be requested and released by Process objects.
Resource(int) - Constructor for class umontreal.iro.lecuyer.simprocs.Resource
Constructs a new resource linked with the default simulator, with initial capacity capacity, and service policy FIFO.
Resource(ProcessSimulator, int) - Constructor for class umontreal.iro.lecuyer.simprocs.Resource
Constructs a new resource linked with the simulator sim, with initial capacity capacity, and service policy FIFO.
Resource(int, String) - Constructor for class umontreal.iro.lecuyer.simprocs.Resource
Constructs a new resource linked with the default simulator, with initial capacity capacity, service policy FIFO, and identifier name.
Resource(ProcessSimulator, int, String) - Constructor for class umontreal.iro.lecuyer.simprocs.Resource
Constructs a new resource linked with the simulator sim, with initial capacity capacity, service policy FIFO, and identifier (or name) name.
restMass2() - Method in class hephysics.vec.HepLorentzVector
Rest mass squared -- same as m2()
restoreImports() - Method in class umontreal.iro.lecuyer.util.ClassFinder
Restores the list of import declarations.
restoreMessages() - Method in class flanagan.math.ArrayMaths
 
restoreMessages() - Static method in class flanagan.math.Conv
 
restoreMessagesAM() - Static method in class flanagan.math.Conv
 
restoreMessagesTotal() - Static method in class flanagan.math.ArrayMaths
 
resume() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Places this process at the beginning of the event list to resume its execution.
retainAll(AbstractBooleanList) - Method in class cern.colt.list.AbstractBooleanList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractByteList) - Method in class cern.colt.list.AbstractByteList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractCharList) - Method in class cern.colt.list.AbstractCharList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractDoubleList) - Method in class cern.colt.list.AbstractDoubleList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractFloatList) - Method in class cern.colt.list.AbstractFloatList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractIntList) - Method in class cern.colt.list.AbstractIntList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractLongList) - Method in class cern.colt.list.AbstractLongList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractShortList) - Method in class cern.colt.list.AbstractShortList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractBooleanList) - Method in class cern.colt.list.BooleanArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractByteList) - Method in class cern.colt.list.ByteArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractCharList) - Method in class cern.colt.list.CharArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractDoubleList) - Method in class cern.colt.list.DoubleArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractFloatList) - Method in class cern.colt.list.FloatArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractIntList) - Method in class cern.colt.list.IntArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractLongList) - Method in class cern.colt.list.LongArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(ObjectArrayList, boolean) - Method in class cern.colt.list.ObjectArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractShortList) - Method in class cern.colt.list.ShortArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractBooleanList) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractBooleanList) - Method in class cern.colt.list.tboolean.BooleanArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractByteList) - Method in class cern.colt.list.tbyte.AbstractByteList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractByteList) - Method in class cern.colt.list.tbyte.ByteArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractCharList) - Method in class cern.colt.list.tchar.AbstractCharList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractCharList) - Method in class cern.colt.list.tchar.CharArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractDoubleList) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractDoubleList) - Method in class cern.colt.list.tdouble.DoubleArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractFloatList) - Method in class cern.colt.list.tfloat.AbstractFloatList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractFloatList) - Method in class cern.colt.list.tfloat.FloatArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractIntList) - Method in class cern.colt.list.tint.AbstractIntList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractIntList) - Method in class cern.colt.list.tint.IntArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractLongList) - Method in class cern.colt.list.tlong.AbstractLongList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractLongList) - Method in class cern.colt.list.tlong.LongArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(ObjectArrayList, boolean) - Method in class cern.colt.list.tobject.ObjectArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractShortList) - Method in class cern.colt.list.tshort.AbstractShortList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(AbstractShortList) - Method in class cern.colt.list.tshort.ShortArrayList
Retains (keeps) only the elements in the receiver that are contained in the specified other list.
retainAll(Collection<?>) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
reverse() - Method in class cern.colt.list.AbstractBooleanList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractByteList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractCharList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractDoubleList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractFloatList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractIntList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractLongList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.AbstractShortList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.BooleanArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.ByteArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.CharArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.DoubleArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.FloatArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.IntArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.LongArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.ObjectArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.ShortArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tboolean.AbstractBooleanList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tboolean.BooleanArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tbyte.AbstractByteList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tbyte.ByteArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tchar.AbstractCharList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tchar.CharArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tdouble.AbstractDoubleList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tdouble.DoubleArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tfloat.AbstractFloatList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tfloat.FloatArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tint.AbstractIntList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tint.IntArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tlong.AbstractLongList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tlong.LongArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tobject.ObjectArrayList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tshort.AbstractShortList
Reverses the elements of the receiver.
reverse() - Method in class cern.colt.list.tshort.ShortArrayList
Reverses the elements of the receiver.
reverse() - Method in class flanagan.analysis.Stat
 
reverse() - Method in class flanagan.math.ArrayMaths
 
reverse(int) - Static method in class jhplot.math.SortUtils
Create reverse permutation, that is {n-1, ....
reverse() - Method in class jhplot.P0D
Reverse the order of elements
reverse() - Method in class jhplot.P0I
Reverse the order of elements
reverseArray(double[]) - Static method in class flanagan.math.Fmath
 
reverseArray(float[]) - Static method in class flanagan.math.Fmath
 
reverseArray(int[]) - Static method in class flanagan.math.Fmath
 
reverseArray(long[]) - Static method in class flanagan.math.Fmath
 
reverseArray(char[]) - Static method in class flanagan.math.Fmath
 
reverseDigits(int, int[], int[]) - Static method in class umontreal.iro.lecuyer.hups.RadicalInverse
Given the k b-ary digits of i in bdigits, returns the k digits of the integer radical inverse of i in idigits.
reverseYsign(String) - Method in class flanagan.analysis.Regression
 
revert() - Method in class org.apache.commons.math.geometry.Rotation
Revert a rotation.
richardson(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using the Richardson extrapolation.
RiddersSolver - Class in org.apache.commons.math.analysis.solvers
Implements the Ridders' Method for root finding of real univariate functions.
RiddersSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.solvers.RiddersSolver
Deprecated. as of 2.0 the function to solve is passed as an argument to the RiddersSolver.solve(UnivariateRealFunction, double, double) or UnivariateRealSolver.solve(UnivariateRealFunction, double, double, double) method.
RiddersSolver() - Constructor for class org.apache.commons.math.analysis.solvers.RiddersSolver
Deprecated. in 2.2
RIGHT - Static variable in class cern.colt.matrix.AbstractFormatter
The alignment string aligning the cells of a column to the right.
RIGHT - Static variable in class cern.colt.matrix.impl.AbstractFormatter
The alignment string aligning the cells of a column to the right.
rightMatrixScramble(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Applies a linear scramble by multiplying each Cj on the right by a single k×k nonsingular upper-triangular matrix M, as suggested by Faure and Tezuka.
rightMatrixScramble(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
rightWithin(Rectangle, Dimension) - Static method in class jhplot.v3d.Util
 
rightWithin(Component, Component) - Static method in class jhplot.v3d.Util
Puts to the right
rint - Static variable in class cern.jet.math.Functions
Function that returns Math.rint(a).
rint - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.rint(a).
rint - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.rint(a).
rint() - Method in class flanagan.analysis.Stat
 
rint() - Method in class flanagan.math.ArrayMaths
 
RINT - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.rint method wrapped as a ComposableFunction.
rint() - Method in class org.apache.commons.math.dfp.Dfp
Round to nearest integer using the round-half-even method.
rint(double) - Static method in class org.apache.commons.math.util.FastMath
Get the whole number that is the nearest to x, or the even one if x is exactly half way between two integers.
rm(String) - Method in class hep.aida.ref.tree.Tree
Remove an IManagedObject by specifying its path.
rmdir(String) - Method in class hep.aida.ref.tree.Tree
Remove a directory and all the contents underneath.
rms() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the rms (Root Mean Square), which is Math.sqrt( Sum( x[i]*x[i] ) / size() ).
rms - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.rms().
rms() - Method in class cern.hep.aida.ref.Histogram1D
 
rms(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the RMS (Root-Mean-Square) of a data sequence.
rms(int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the RMS (Root-Mean-Square) of a data sequence.
rms(int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the RMS (Root-Mean-Square) of a data sequence.
rms() - Method in class flanagan.analysis.Stat
 
rms(double[]) - Static method in class flanagan.analysis.Stat
 
rms(float[]) - Static method in class flanagan.analysis.Stat
 
rms(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
rms(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
rms(double[], double[]) - Static method in class flanagan.analysis.Stat
 
rms(float[], float[]) - Static method in class flanagan.analysis.Stat
 
rms(BigDecimal[], BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
rms(BigInteger[], BigInteger[]) - Static method in class flanagan.analysis.Stat
 
rms(int[], int) - Method in interface hep.aida.ref.dataset.binner.Binner
Get the rms of a bin along a given coordinate.
rms(int[], int) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Get the rms of a bin along a given coordinate.
rms(int) - Method in class hep.aida.ref.dataset.DataStatistics
Get the rms for a given coordinate.
rms(int) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
rms(int) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
rms() - Method in class hep.aida.ref.histogram.Cloud1D
Get the Cloud's rms.
rms() - Method in class hep.aida.ref.histogram.Histogram1D
Get the RMS of the whole Histogram.
rms() - Method in class hep.aida.ref.histogram.Profile1D
 
rms() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
rms() - Method in class hep.aida.ref.tuple.TupleColumn
 
rms() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns the rms (Root Mean Square), which is Math.sqrt( Sum( x[i]*x[i] ) / size() ).
rms - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.rms().
rms() - Method in interface hep.aida.tdouble.DoubleIHistogram1D
Returns the rms of the whole histogram as calculated on filling-time.
rms() - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
 
rms() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns the rms (Root Mean Square), which is Math.sqrt( Sum( x[i]*x[i] ) / size() ).
rms - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.rms().
rms() - Method in interface hep.aida.tfloat.FloatIHistogram1D
Returns the rms of the whole histogram as calculated on filling-time.
rms() - Method in class hep.aida.tfloat.ref.FloatHistogram1D
 
rms() - Method in class jhplot.H1D
Get RMS of histogram
rms() - Method in class jhplot.HProf1D
Get RMS of histogram
rmsValue(Value) - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
rmsValue(Value) - Method in interface hep.aida.ref.tuple.FTupleColumn
 
rmsValue(Value) - Method in class hep.aida.ref.tuple.TupleColumn
 
rmsX() - Method in class cern.hep.aida.ref.Histogram2D
 
rmsX() - Method in class cern.hep.aida.ref.Histogram3D
 
rmsX(int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
rmsX(int, int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
rmsX(int, int) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
rmsX(int, int, int) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
rmsX(int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
rmsX(int, int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
rmsX() - Method in class hep.aida.ref.histogram.Cloud2D
Get the Cloud's x rms.
rmsX() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's x rms.
rmsX() - Method in class hep.aida.ref.histogram.Histogram2D
Get the RMS of the whole Histogram as projected on the x axis.
rmsX() - Method in class hep.aida.ref.histogram.Histogram3D
Get the RMS of the whole Histogram as projected on the x axis.
rmsX() - Method in class hep.aida.ref.histogram.Profile2D
 
rmsX() - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Returns the rms of the histogram as calculated on filling-time projected on the X axis.
rmsX() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Returns the rms of the histogram as calculated on filling-time projected on the X axis.
rmsX() - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
rmsX() - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
rmsX() - Method in interface hep.aida.tfloat.FloatIHistogram2D
Returns the rms of the histogram as calculated on filling-time projected on the X axis.
rmsX() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Returns the rms of the histogram as calculated on filling-time projected on the X axis.
rmsX() - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
rmsX() - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
rmsX() - Method in class jhplot.P1D
Returns RMS for X-values.
rmsY() - Method in class cern.hep.aida.ref.Histogram2D
 
rmsY() - Method in class cern.hep.aida.ref.Histogram3D
 
rmsY(int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
rmsY(int, int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
rmsY(int, int) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
rmsY(int, int, int) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
rmsY(int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
rmsY(int, int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
rmsY() - Method in class hep.aida.ref.histogram.Cloud2D
Get the Cloud's y rms.
rmsY() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's y rms.
rmsY() - Method in class hep.aida.ref.histogram.Histogram2D
Get the RMS of the whole Histogram as projected on the y axis.
rmsY() - Method in class hep.aida.ref.histogram.Histogram3D
Get the RMS of the whole Histogram as projected on the y axis.
rmsY() - Method in class hep.aida.ref.histogram.Profile2D
 
rmsY() - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Returns the rms of the histogram as calculated on filling-time projected on the Y axis.
rmsY() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Returns the rms of the histogram as calculated on filling-time projected on the Y axis.
rmsY() - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
rmsY() - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
rmsY() - Method in interface hep.aida.tfloat.FloatIHistogram2D
Returns the rms of the histogram as calculated on filling-time projected on the Y axis.
rmsY() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Returns the rms of the histogram as calculated on filling-time projected on the Y axis.
rmsY() - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
rmsY() - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
rmsY() - Method in class jhplot.P1D
Returns RMS for Y-values.
rmsZ() - Method in class cern.hep.aida.ref.Histogram3D
 
rmsZ(int, int, int) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
rmsZ(int, int, int) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
rmsZ(int, int, int) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
rmsZ() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's z rms.
rmsZ() - Method in class hep.aida.ref.histogram.Histogram3D
Get the RMS of the whole Histogram as projected on the z axis.
rmsZ() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Returns the rms of the histogram as calculated on filling-time projected on the Z axis.
rmsZ() - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
rmsZ() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Returns the rms of the histogram as calculated on filling-time projected on the Z axis.
rmsZ() - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
RNG - Interface in jhplot.math.num.random
Defines a random number generator that is capable of generating sequences of random numbers uniformly distributed between zero and one.
RombergIntegrator - Class in jhplot.math.num.integration
An implementation of Romberg Integration.
RombergIntegrator(Function) - Constructor for class jhplot.math.num.integration.RombergIntegrator
Create an integrator for the given function.
RombergIntegrator(Function, int, double) - Constructor for class jhplot.math.num.integration.RombergIntegrator
Create an integrator for the given function.
RombergIntegrator - Class in org.apache.commons.math.analysis.integration
Implements the Romberg Algorithm for integration of real univariate functions.
RombergIntegrator(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.integration.RombergIntegrator
Deprecated. as of 2.0 the integrand function is passed as an argument to the RombergIntegrator.integrate(UnivariateRealFunction, double, double)method.
RombergIntegrator() - Constructor for class org.apache.commons.math.analysis.integration.RombergIntegrator
Construct an integrator.
RootFinder - Class in umontreal.iro.lecuyer.util
This class provides methods to solve non-linear equations.
RootHistogramBrowser - Class in jhplot.root
A simple application for browsing histograms in Root Files
RootHistogramBrowser() - Constructor for class jhplot.root.RootHistogramBrowser
Histogram browser
rotatedCumulativePercentage() - Method in class flanagan.analysis.PCA
 
rotatedEigenValues() - Method in class flanagan.analysis.PCA
 
rotatedLoadingFactorsAsColumns() - Method in class flanagan.analysis.PCA
 
rotatedLoadingFactorsAsRows() - Method in class flanagan.analysis.PCA
 
rotatedProportionPercentage() - Method in class flanagan.analysis.PCA
 
Rotation - Class in org.apache.commons.math.geometry
This class implements rotations in a three-dimensional space.
Rotation(double, double, double, double, boolean) - Constructor for class org.apache.commons.math.geometry.Rotation
Build a rotation from the quaternion coordinates.
Rotation(Vector3D, double) - Constructor for class org.apache.commons.math.geometry.Rotation
Build a rotation from an axis and an angle.
Rotation(double[][], double) - Constructor for class org.apache.commons.math.geometry.Rotation
Build a rotation from a 3X3 matrix.
Rotation(Vector3D, Vector3D, Vector3D, Vector3D) - Constructor for class org.apache.commons.math.geometry.Rotation
Build the rotation that transforms a pair of vector into another pair.
Rotation(Vector3D, Vector3D) - Constructor for class org.apache.commons.math.geometry.Rotation
Build one of the rotations that transform one vector into another one.
Rotation(RotationOrder, double, double, double) - Constructor for class org.apache.commons.math.geometry.Rotation
Build a rotation from three Cardan or Euler elementary rotations.
RotationOrder - Class in org.apache.commons.math.geometry
This class is a utility representing a rotation order specification for Cardan or Euler angles specification.
round(double) - Static method in class cern.jet.math.Functions
Constructs a function that returns the number rounded to the given precision; Math.rint(a/precision)*precision.
round(double) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns the number rounded to the given precision; Math.rint(a/precision)*precision.
round(float) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns the number rounded to the given precision; Math.rint(a/precision)*precision.
round(double) - Static method in class org.apache.commons.math.util.FastMath
Get the closest long to x.
round(float) - Static method in class org.apache.commons.math.util.FastMath
Get the closest int to x.
round(double, int) - Static method in class org.apache.commons.math.util.MathUtils
Round the given value to the specified number of decimal places.
round(double, int, int) - Static method in class org.apache.commons.math.util.MathUtils
Round the given value to the specified number of decimal places.
round(float, int) - Static method in class org.apache.commons.math.util.MathUtils
Round the given value to the specified number of decimal places.
round(float, int, int) - Static method in class org.apache.commons.math.util.MathUtils
Round the given value to the specified number of decimal places.
roundDown(double, int) - Static method in class hep.aida.ref.AidaUtils
Round number down (closer to Negative Infinity): "order" defines which significant digit is rounded, order >= 0 roundDown(234.5, 0) -> 200.0 roundDown(234.5, 1) -> 230.0 roundDown(234.5, 2) -> 234.0
roundUp(double, int) - Static method in class hep.aida.ref.AidaUtils
Round number up (closer to Positive Infinity), "order" defines which significant digit is rounded, order >= 0 roundUp(234.5, 0) -> 300.0 roundUp(234.5, 1) -> 240.0 roundUp(234.5, 2) -> 235.0
row() - Method in interface hep.aida.ref.tuple.FTupleCursor
 
row() - Method in class hep.aida.ref.tuple.TupleCursor
 
rowCompressed - Static variable in class cern.colt.matrix.DoubleFactory2D
A factory producing sparse row compressed matrices.
rowCompressed - Static variable in class cern.colt.matrix.tint.IntFactory2D
A factory producing sparse row compressed matrices.
rowCompressed - Static variable in class cern.colt.matrix.tlong.LongFactory2D
A factory producing sparse row compressed matrices.
rowMatrix(double[]) - Static method in class flanagan.math.Matrix
 
rowMaxima() - Method in class flanagan.math.Matrix
 
rowMeans() - Method in class flanagan.math.Matrix
 
rowMedians() - Method in class flanagan.math.Matrix
 
rowMinima() - Method in class flanagan.math.Matrix
 
rowRanges() - Method in class flanagan.math.Matrix
 
rows() - Method in class cern.colt.bitvector.BitMatrix
Returns the number of rows of the receiver.
rows() - Method in class cern.colt.matrix.AbstractMatrix2D
Returns the number of rows.
rows() - Method in class cern.colt.matrix.AbstractMatrix3D
Returns the number of rows.
rows() - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Returns the number of rows.
rows() - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Returns the number of rows.
rows() - Method in class cern.colt.matrix.tbit.BitMatrix
Returns the number of rows of the receiver.
rows() - Method in class hep.aida.ref.tuple.AbstractTuple
 
rows() - Method in class hep.aida.ref.tuple.ChainedTuple
The number of rows currently in the ntuple.
rows() - Method in interface hep.aida.ref.tuple.FTuple
 
rows() - Method in class hep.aida.ref.tuple.FTupleAdapter
 
rows() - Method in class hep.aida.ref.tuple.Tuple
 
ROWS_UNKNOWN - Static variable in interface hep.aida.ref.tuple.FTuple
 
rowStandardDeviations() - Method in class flanagan.math.Matrix
 
rowStandardErrors() - Method in class flanagan.math.Matrix
 
rowStride() - Method in class cern.colt.matrix.AbstractMatrix2D
Returns the row stride.
rowStride() - Method in class cern.colt.matrix.AbstractMatrix3D
Returns the row stride.
rowSums() - Method in class flanagan.math.Matrix
 
rowVariances() - Method in class flanagan.math.Matrix
 
rowVector(double[]) - Static method in class jhplot.math.DoubleArray
Converts an n element array into an 1 x n matrix.
rr - Variable in class jhplot.io.HDataBase
 
run() - Method in class jhplot.HBsom
Run the algorithm
run(double[]) - Method in class jhplot.stat.BunchingParameters
Collect information about sampling.
run(double[]) - Method in class jhplot.stat.FactorialMoments
Collect information about sampling.
run() - Method in class jhplot.v3d.Animation
 
run(boolean) - Method in class jhpro.stat.limit.StatConfidence
Run limit calculations.
run(int) - Method in class jminhep.cluster.Partition
Main method to run cluster algorithm
RungeKutta - Class in flanagan.integration
 
RungeKutta() - Constructor for class flanagan.integration.RungeKutta
 
rungeKutta2(double[], F1D, double) - Static method in class jhplot.math.Numeric
Uses the 2nd order Runge-Kutta method to solve an ODE.
rungeKutta4(double[], F1D, double) - Static method in class jhplot.math.Numeric
Uses the 4th order Runge-Kutta method to solve an ODE.
RungeKuttaIntegrator - Class in org.apache.commons.math.ode.nonstiff
This class implements the common part of all fixed step Runge-Kutta integrators for Ordinary Differential Equations.
rw - Variable in class jhplot.io.HDataBase
 
rxy() - Method in class hephysics.vec.SpacePoint
Cylindrical r
rxyz() - Method in class hephysics.vec.SpacePoint
Spherical r

S

s - Static variable in class cern.clhep.Units
 
s(String) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Same as s (0, str).
s(int, String) - Static method in class umontreal.iro.lecuyer.util.PrintfFormat
Formats the string str like the %s in the C printf function.
SaddlePoint - Class in jhplot.math.num.pdf
Utility class used by various distributions to accurately compute their respective probability mass functions.
SaddlePoint() - Constructor for class jhplot.math.num.pdf.SaddlePoint
Default constructor.
SAFE_MIN - Static variable in class org.apache.commons.math.util.MathUtils
Safe minimum, such that 1 / SAFE_MIN does not overflow.
safeNorm(double[]) - Static method in class org.apache.commons.math.util.MathUtils
Returns the Cartesian norm (2-norm), handling both overflow and underflow.
saintAndrewsDay() - Method in class flanagan.math.TimeAndDate
 
saintAndrewsDay(int) - Method in class flanagan.math.TimeAndDate
 
saintBrigidsDay() - Method in class flanagan.math.TimeAndDate
 
saintBrigidsDay(int) - Method in class flanagan.math.TimeAndDate
 
saintColmCillesDay() - Method in class flanagan.math.TimeAndDate
 
saintColmcillesDay() - Method in class flanagan.math.TimeAndDate
 
saintColmCillesDay(int) - Method in class flanagan.math.TimeAndDate
 
saintColmcillesDay(int) - Method in class flanagan.math.TimeAndDate
 
saintColumbasDay() - Method in class flanagan.math.TimeAndDate
 
saintColumbasDay(int) - Method in class flanagan.math.TimeAndDate
 
saintDavidsDay() - Method in class flanagan.math.TimeAndDate
 
saintDavidsDay(int) - Method in class flanagan.math.TimeAndDate
 
saintGeorgesDay() - Method in class flanagan.math.TimeAndDate
 
saintGeorgesDay(int) - Method in class flanagan.math.TimeAndDate
 
saintPatricksDay() - Method in class flanagan.math.TimeAndDate
 
saintPatricksDay(int) - Method in class flanagan.math.TimeAndDate
 
saintStephensDay() - Method in class flanagan.math.TimeAndDate
 
saintStephensDay(int) - Method in class flanagan.math.TimeAndDate
 
saintValentinesDay() - Method in class flanagan.math.TimeAndDate
 
saintValentinesDay(int) - Method in class flanagan.math.TimeAndDate
 
sameSignature(Method, Method) - Static method in class umontreal.iro.lecuyer.util.Introspection
Determines if two methods m1 and m2 share the same signature.
sample(int, double, double) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a randomly sampled matrix with the given shape.
sample(int, int, double, double) - Method in class cern.colt.matrix.DoubleFactory2D
Constructs a randomly sampled matrix with the given shape.
sample(DoubleMatrix2D, double, double) - Method in class cern.colt.matrix.DoubleFactory2D
Modifies the given matrix to be a randomly sampled matrix.
sample(int, double[], double) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory1D
Constructs a randomly sampled matrix with the given shape.
sample(int, int, double[], double) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Constructs a randomly sampled matrix with the given shape.
sample(DComplexMatrix2D, double[], double) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory2D
Modifies the given matrix to be a randomly sampled matrix.
sample(int, double, double) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
Constructs a randomly sampled matrix with the given shape.
sample(DoubleMatrix2D, double, double) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Modifies the given matrix to be a randomly sampled matrix.
sample(int, int, double, double) - Method in class cern.colt.matrix.tdouble.DoubleFactory2D
Constructs a randomly sampled matrix with the given shape.
sample(int, float[], float) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory1D
Constructs a randomly sampled matrix with the given shape.
sample(int, int, float[], float) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Constructs a randomly sampled matrix with the given shape.
sample(FComplexMatrix2D, float[], float) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory2D
Modifies the given matrix to be a randomly sampled matrix.
sample(int, float, float) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
Constructs a randomly sampled matrix with the given shape.
sample(FloatMatrix2D, float, float) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Modifies the given matrix to be a randomly sampled matrix.
sample(int, int, float, float) - Method in class cern.colt.matrix.tfloat.FloatFactory2D
Constructs a randomly sampled matrix with the given shape.
sample(int, int, int) - Method in class cern.colt.matrix.tint.IntFactory1D
Constructs a randomly sampled matrix with the given shape.
sample(int, int, int, int) - Method in class cern.colt.matrix.tint.IntFactory2D
Constructs a randomly sampled matrix with the given shape.
sample(IntMatrix2D, int, int) - Method in class cern.colt.matrix.tint.IntFactory2D
Modifies the given matrix to be a randomly sampled matrix.
sample(int, int, int) - Method in class cern.colt.matrix.tlong.LongFactory1D
Constructs a randomly sampled matrix with the given shape.
sample(int, int, int, int) - Method in class cern.colt.matrix.tlong.LongFactory2D
Constructs a randomly sampled matrix with the given shape.
sample(LongMatrix2D, int, int) - Method in class cern.colt.matrix.tlong.LongFactory2D
Modifies the given matrix to be a randomly sampled matrix.
sample(int, boolean, RandomEngine, DoubleBuffer) - Method in class cern.hep.aida.bin.DynamicBin1D
Uniformly samples (chooses) n random elements with or without replacement from the contained elements and adds them to the given buffer.
sample(long, long, int, long, long[], int, RandomEngine) - Static method in class cern.jet.random.sampling.RandomSampler
Efficiently computes a sorted random set of count elements from the interval [low,low+N-1].
sample(long, long, int, long, long[], int, DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.sampling.DoubleRandomSampler
Efficiently computes a sorted random set of count elements from the interval [low,low+N-1].
sample(long, long, int, long, long[], int, FloatRandomEngine) - Static method in class cern.jet.random.tfloat.sampling.FloatRandomSampler
Efficiently computes a sorted random set of count elements from the interval [low,low+N-1].
sample(int, boolean, DoubleRandomEngine, DoubleBuffer) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Uniformly samples (chooses) n random elements with or without replacement from the contained elements and adds them to the given buffer.
sample(int, boolean, FloatRandomEngine, FloatBuffer) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Uniformly samples (chooses) n random elements with or without replacement from the contained elements and adds them to the given buffer.
sample() - Method in class org.apache.commons.math.distribution.AbstractContinuousDistribution
Generates a random value sampled from this distribution.
sample(int) - Method in class org.apache.commons.math.distribution.AbstractContinuousDistribution
Generates a random sample from the distribution.
sample() - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
Generates a random value sampled from this distribution.
sample(int) - Method in class org.apache.commons.math.distribution.AbstractIntegerDistribution
Generates a random sample from the distribution.
sample() - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Generates a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Generates a random value sampled from this distribution.
sample() - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Generates a random value sampled from this distribution.
sample(UnivariateRealFunction, double, double, int) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Sample the given univariate real function on the given interval.
sampleArray(int, int[]) - Static method in class cern.jet.random.sampling.RandomSamplingAssistant
Just shows how this class can be used; samples n elements from and int[] array.
sampleArray(int, int[]) - Static method in class cern.jet.random.tdouble.sampling.DoubleRandomSamplingAssistant
Just shows how this class can be used; samples n elements from and int[] array.
sampleArray(int, int[]) - Static method in class cern.jet.random.tfloat.sampling.FloatRandomSamplingAssistant
Just shows how this class can be used; samples n elements from and int[] array.
sampleBootstrap(DynamicBin1D, int, RandomEngine, BinBinFunction1D) - Method in class cern.hep.aida.bin.DynamicBin1D
Generic bootstrap resampling.
sampleBootstrap(DynamicDoubleBin1D, int, DoubleRandomEngine, DoubleBinBinFunction1D) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Generic bootstrap resampling.
sampleBootstrap(DynamicFloatBin1D, int, FloatRandomEngine, FloatBinBinFunction1D) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Generic bootstrap resampling.
sampleKurtosis(int, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample kurtosis (aka excess) of a data sequence.
sampleKurtosis(DoubleArrayList, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample kurtosis (aka excess) of a data sequence.
sampleKurtosis(int, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sample kurtosis (aka excess) of a data sequence.
sampleKurtosis(DoubleArrayList, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sample kurtosis (aka excess) of a data sequence.
sampleKurtosis(int, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sample kurtosis (aka excess) of a data sequence.
sampleKurtosis(FloatArrayList, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sample kurtosis (aka excess) of a data sequence.
sampleKurtosisStandardError(int) - Static method in class cern.jet.stat.Descriptive
Return the standard error of the sample kurtosis.
sampleKurtosisStandardError(int) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Return the standard error of the sample kurtosis.
sampleKurtosisStandardError(int) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Return the standard error of the sample kurtosis.
sampleNextElement() - Method in class cern.jet.random.sampling.RandomSamplingAssistant
Returns whether the next element of the input sequence shall be sampled (picked) or not.
sampleNextElement() - Method in class cern.jet.random.sampling.WeightedRandomSampler
Chooses exactly one random element from successive blocks of weight input elements each.
sampleNextElement() - Method in class cern.jet.random.tdouble.sampling.DoubleRandomSamplingAssistant
Returns whether the next element of the input sequence shall be sampled (picked) or not.
sampleNextElement() - Method in class cern.jet.random.tdouble.sampling.WeightedDoubleRandomSampler
Chooses exactly one random element from successive blocks of weight input elements each.
sampleNextElement() - Method in class cern.jet.random.tfloat.sampling.FloatRandomSamplingAssistant
Returns whether the next element of the input sequence shall be sampled (picked) or not.
sampleNextElement() - Method in class cern.jet.random.tfloat.sampling.WeightedFloatRandomSampler
Chooses exactly one random element from successive blocks of weight input elements each.
sampleSkew(int, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample skew of a data sequence.
sampleSkew(DoubleArrayList, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample skew of a data sequence.
sampleSkew(int, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sample skew of a data sequence.
sampleSkew(DoubleArrayList, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sample skew of a data sequence.
sampleSkew(int, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sample skew of a data sequence.
sampleSkew(FloatArrayList, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sample skew of a data sequence.
sampleSkewStandardError(int) - Static method in class cern.jet.stat.Descriptive
Return the standard error of the sample skew.
sampleSkewStandardError(int) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Return the standard error of the sample skew.
sampleSkewStandardError(int) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Return the standard error of the sample skew.
sampleStandardDeviation(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample standard deviation.
sampleStandardDeviation(int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sample standard deviation.
sampleStandardDeviation(int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sample standard deviation.
sampleVariance(int, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample variance of a data sequence.
sampleVariance(DoubleArrayList, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample variance of a data sequence.
sampleVariance(int, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sample variance of a data sequence.
sampleVariance(DoubleArrayList, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sample variance of a data sequence.
sampleVariance(int, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sample variance of a data sequence.
sampleVariance(FloatArrayList, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sample variance of a data sequence.
sampleWeightedVariance(double, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the sample weighted variance of a data sequence.
sampleWeightedVariance(double, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sample weighted variance of a data sequence.
sampleWeightedVariance(float, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sample weighted variance of a data sequence.
SArc(float, float, float, float, float, float) - Static method in class jhplot.jadraw.Diagram
A s-line for scalar particles.
sasum(int, float[], int) - Method in class org.netlib.blas.BLAS
..
save(String, String, String) - Method in class jhplot.HNeuralNet
Save current status of neural net.
saveImports() - Method in class umontreal.iro.lecuyer.util.ClassFinder
Saves the current import list on the import stack.
saxpy(int, float, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
sbdsdc(String, String, int, float[], float[], float[], int, float[], int, float[], int[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sbdsqr(String, int, int, int, int, float[], float[], float[], int, float[], int, float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
scalarAdd(T) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the result of adding d to each entry of this.
scalarAdd(double) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the result of adding d to each entry of this.
scalarAdd(BigDecimal) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the result of adding d to each entry of this.
scalarAdd(BigDecimal) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the result of adding d to each entry of this.
scalarAdd(T) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the result of adding d to each entry of this.
scalarAdd(double) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the result of adding d to each entry of this.
scalarAdd(T) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the result of adding d to each entry of this.
scalarAdd(double) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result of adding d to each entry of this.
scalarMatrix(int, double) - Static method in class flanagan.math.Matrix
 
scalarMatrix(int, int, double) - Static method in class flanagan.math.Matrix
 
scalarMultiply(double, double[]) - Static method in class jhplot.math.ArrayMathUtils
Multiplies every component of an array by a scalar.
scalarMultiply(double, int[]) - Static method in class jhplot.math.ArrayMathUtils
Multiplies every component of an array by a scalar.
scalarMultiply(double) - Method in class org.apache.commons.math.geometry.Vector3D
Multiply the instance by a scalar
scalarMultiply(T) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the result multiplying each entry of this by d.
scalarMultiply(double) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the result multiplying each entry of this by d.
scalarMultiply(BigDecimal) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the result multiplying each entry of this by d.
scalarMultiply(BigDecimal) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the result of multiplying each entry of this by d
scalarMultiply(T) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the result multiplying each entry of this by d.
scalarMultiply(double) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the result multiplying each entry of this by d.
scalarMultiply(T) - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the result multiplying each entry of this by d.
scalarMultiply(double) - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the result multiplying each entry of this by d.
scalarMultiplyFast(double, double[]) - Static method in class jhplot.math.ArrayMathUtils
Fast scalar multiplication for sparse arrays.
scalarMultiplyFast(double, int[]) - Static method in class jhplot.math.ArrayMathUtils
Fast scalar multiplication for sparse arrays.
scalarProduct(double[], double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the scalar product of two array as if they were vectors.
scalarProduct(double[][], double[][]) - Static method in class jhplot.math.ArrayMathUtils
Computes the scalar product of two array as if they were matrices.
scalarProduct(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the scalar product of two array as if they were vectors.
scalarProduct(int[][], int[][]) - Static method in class jhplot.math.ArrayMathUtils
Computes the scalar product of two array as if they were matrices.
scalarProduct(BitVector) - Method in class umontreal.iro.lecuyer.util.BitVector
Returns the scalar product of two BitVector's modulo 2.
scalb(double, int) - Static method in class org.apache.commons.math.util.FastMath
Multiply a double number by a power of 2.
scalb(float, int) - Static method in class org.apache.commons.math.util.FastMath
Multiply a float number by a power of 2.
scalb(double, int) - Static method in class org.apache.commons.math.util.MathUtils
Deprecated. as of 2.2, replaced by FastMath.scalb(double, int)
scale(double, double) - Method in class flanagan.analysis.Stat
 
scale(double[], double, double) - Static method in class flanagan.analysis.Stat
 
scale(float[], float, float) - Static method in class flanagan.analysis.Stat
 
scale(long[], double, double) - Static method in class flanagan.analysis.Stat
 
scale(int[], double, double) - Static method in class flanagan.analysis.Stat
 
scale(BigDecimal[], double, double) - Static method in class flanagan.analysis.Stat
 
scale(BigInteger[], double, double) - Static method in class flanagan.analysis.Stat
 
scale(double) - Method in interface hep.aida.ref.dataset.binner.Binner
Scale all the bins by a given scale factor.
scale(double) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Scale all the bins by a given scale factor.
scale(double) - Method in class hep.aida.ref.dataset.DataStatistics
Scale the statistics by a give scaleFactor Rescaling is equivalent to multiplying all the weights by the scale factor.
scale(double) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
scale(double) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
scale(double) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
scale(double) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
scale(double) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
scale(double) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
scale(double) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
scale(double) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
scale(double) - Method in class hep.aida.ref.histogram.Cloud
Scale the weights by a given factor.
scale(double) - Method in class hep.aida.ref.histogram.Cloud1D
 
scale(double) - Method in class hep.aida.ref.histogram.Cloud2D
 
scale(double) - Method in class hep.aida.ref.histogram.Cloud3D
 
scale(double) - Method in class hep.aida.ref.histogram.DataPointSet
 
scale(double) - Method in class hep.aida.ref.histogram.Histogram
Scale the weights and the errors by a given factor.
scale(double) - Method in class hep.aida.ref.histogram.Histogram1D
Scale the weights and the errors by a given factor.
scale(double) - Method in class hep.aida.ref.histogram.Histogram2D
Scale the weights and the errors by a given factor.
scale(double) - Method in class hep.aida.ref.histogram.Histogram3D
Scale the weights and the errors by a given factor.
scale(double) - Method in class hep.aida.ref.histogram.Profile1D
 
scale(double) - Method in class hep.aida.ref.histogram.Profile2D
 
scale(String, double) - Method in class jhplot.H1D
Scale the histogram.
scale(double) - Method in class jhplot.H1D
Scale the histogram.
scale(String, double) - Method in class jhplot.H2D
Scale the histogram.
scale(double) - Method in class jhplot.H2D
Scale the histogram.
scale(String, double) - Method in class jhplot.HProf1D
Scale the histogram.
scale(double) - Method in class jhplot.HProf1D
Scale the histogram.
scale(int, double) - Method in class jhpro.stat.DataKeeper
Scale values and errors by a factor
scale(double) - Method in class jhpro.stat.DataKeeper
Scale all values and errors by a factor
scaleArray(double[], double) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Multiply every component in the given real array by the given real number.
scaleArray(Complex[], double) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Multiply every component in the given complex array by the given real number.
scaledTransformedData() - Method in class flanagan.analysis.BoxCox
 
scaleErrors(double) - Method in class hep.aida.ref.histogram.DataPointSet
 
scalePoint(double, double, double, double, double) - Method in class jhplot.jadraw.JaObject
Returns a point that is obtained from a point (px, py) after a scale transformation scale, keeping the point (orx, ory) fixed.
scaleValues(double) - Method in class hep.aida.ref.histogram.DataPointSet
 
scan(int, double, int) - Static method in class umontreal.iro.lecuyer.gof.FBar
Return P[SN(d ) >= m], where SN(d ) is the scan statistic.
scan(int, double, int) - Static method in class umontreal.iro.lecuyer.gof.FDist
Returns F(m), the distribution function of the scan statistic with parameters N and d, evaluated at m.
scan(DoubleArrayList, double) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Computes and returns the scan statistic SN(d ), defined in FBar.scan.
ScatterChart - Class in umontreal.iro.lecuyer.charts
This class provides tools to create and manage scatter plots.
ScatterChart() - Constructor for class umontreal.iro.lecuyer.charts.ScatterChart
Initializes a new ScatterChart instance with an empty data set.
ScatterChart(String, String, String, double[][]...) - Constructor for class umontreal.iro.lecuyer.charts.ScatterChart
Initializes a new ScatterChart instance with data data.
ScatterChart(String, String, String, double[][], int) - Constructor for class umontreal.iro.lecuyer.charts.ScatterChart
Initializes a new ScatterChart instance with sets of points data.
ScatterChart(String, String, String, double[][], int, int) - Constructor for class umontreal.iro.lecuyer.charts.ScatterChart
Initializes a new ScatterChart instance using subsets of data.
ScatterChart(String, String, String, DoubleArrayList...) - Constructor for class umontreal.iro.lecuyer.charts.ScatterChart
Initializes a new ScatterChart instance with data data.
ScatterChart(String, String, String, XYSeriesCollection) - Constructor for class umontreal.iro.lecuyer.charts.ScatterChart
Initializes a new ScatterChart instance with data data.
schedule(double) - Method in class umontreal.iro.lecuyer.simevents.Event
Schedules this event to happen in delay time units, i.e., at time sim.time() + delay, by inserting it in the event list.
schedule(double) - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Schedules the process to start in delay time units.
scheduleAfter(Event) - Method in class umontreal.iro.lecuyer.simevents.Event
Schedules this event to happen just after, and at the same time, as the event other.
scheduleBefore(Event) - Method in class umontreal.iro.lecuyer.simevents.Event
Schedules this event to happen just before, and at the same time, as the event other.
scheduledEvent() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Returns the Event associated with the current variable.
scheduleNext() - Method in class umontreal.iro.lecuyer.simevents.Event
Schedules this event as the first event in the event list, to be executed at the current time (as the next event).
scheduleNext() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Schedules this process to start at the current time, by placing it at the beginning of the event list.
scopy(int, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
Scores - Class in flanagan.analysis
 
Scores() - Constructor for class flanagan.analysis.Scores
 
screePlot() - Method in class flanagan.analysis.PCA
 
screePlotDataAlone() - Method in class flanagan.analysis.PCA
 
sdisna(String, int, int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sdot(int, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
sdsdot(int, float, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
search(double) - Method in class jhplot.P0D
Search for the first occurrence of the given argument
search(Integer) - Method in class jhplot.P0I
Search for the first occurrence of the given argument
search(UnivariateRealFunction, GoalType, double, double) - Method in class org.apache.commons.math.optimization.univariate.BracketFinder
Search new points that bracket a local optimum of the function.
searchForFitnessUpdate(Population) - Method in class org.apache.commons.math.genetics.Chromosome
Searches the population for a chromosome representing the same solution, and if it finds one, updates the fitness to its value.
sec(double) - Static method in class flanagan.math.Fmath
 
SecantRootFinder - Class in jhplot.math.num.root
The secant method (1) for finding roots of functions.
SecantRootFinder(Function) - Constructor for class jhplot.math.num.root.SecantRootFinder
Create a root finder for the given function.
SecantRootFinder(Function, int, double) - Constructor for class jhplot.math.num.root.SecantRootFinder
Create a root finder for the given function.
SecantSolver - Class in org.apache.commons.math.analysis.solvers
Implements a modified version of the secant method for approximating a zero of a real univariate function.
SecantSolver(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.solvers.SecantSolver
Deprecated. as of 2.0 the function to solve is passed as an argument to the SecantSolver.solve(UnivariateRealFunction, double, double) or UnivariateRealSolver.solve(UnivariateRealFunction, double, double, double) method.
SecantSolver() - Constructor for class org.apache.commons.math.analysis.solvers.SecantSolver
Deprecated. in 2.2 (to be removed in 3.0).
sech(double) - Static method in class flanagan.math.Fmath
 
second - Static variable in class cern.clhep.Units
 
second(floatW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
second() - Method in class org.netlib.lapack.LAPACK
-- LAPACK auxiliary routine (version 3.1.1) -- Univ.
SecondMoment - Class in org.apache.commons.math.stat.descriptive.moment
Computes a statistic related to the Second Central Moment.
SecondMoment() - Constructor for class org.apache.commons.math.stat.descriptive.moment.SecondMoment
Create a SecondMoment instance
SecondMoment(SecondMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.SecondMoment
Copy constructor, creates a new SecondMoment identical to the original
SecondOrderDifferentialEquations - Interface in org.apache.commons.math.ode
This interface represents a second order differential equations set.
SecondOrderIntegrator - Interface in org.apache.commons.math.ode
This interface represents a second order integrator for differential equations.
seconds() - Method in class cern.colt.Timer
Returns the elapsed time in seconds; does not stop the timer, if started.
SECONDS - Static variable in class jhplot.JHPlot
 
seek(long) - Method in class jhplot.math.io.LERandomAccessFile
 
select(Population) - Method in interface org.apache.commons.math.genetics.SelectionPolicy
Select two chromosomes from the population.
select(Population) - Method in class org.apache.commons.math.genetics.TournamentSelection
Select two chromosomes from the population.
SELECT_BODY - Static variable in class jhplot.jadraw.JaObject
An integer that indicates that the user grabbed the body of an object.
SELECT_LL - Static variable in class jhplot.jadraw.JaObject
An integer that indicates that the user grabbed the lower left handle of an object.
SELECT_LR - Static variable in class jhplot.jadraw.JaObject
An integer that indicates that the user grabbed the lower right handle of an object.
SELECT_NONE - Static variable in class jhplot.jadraw.JaObject
An integer that indicates that the user did not grab any object.
SELECT_P1 - Static variable in class jhplot.jadraw.JaObject
An integer that specifies the first point of an arc object.
SELECT_P2 - Static variable in class jhplot.jadraw.JaObject
An integer that specifies the second point of an arc object.
SELECT_P3 - Static variable in class jhplot.jadraw.JaObject
An integer that specifies the third point of an arc object.
SELECT_UL - Static variable in class jhplot.jadraw.JaObject
An integer that indicates that the user grabbed the upper left handle of an object.
SELECT_UR - Static variable in class jhplot.jadraw.JaObject
An integer that indicates that the user grabbed the upper right handle of an object.
selectCoordinates(int[], int) - Method in class umontreal.iro.lecuyer.hups.SubsetOfPointSet
Selects the numCoord coordinates whose numbers are provided in the array coordIndices.
selectCoordinatesRange(int, int) - Method in class umontreal.iro.lecuyer.hups.SubsetOfPointSet
Selects the coordinates from ``from'' to ``to - 1'' from the original point set.
selectEuler(double) - Static method in class umontreal.iro.lecuyer.simevents.Continuous
Selects the Euler method as the integration method, with the integration step size h, in time units, for the default simulator.
selectEuler(double) - Method in class umontreal.iro.lecuyer.simevents.ContinuousState
Selects the Euler method as the integration method, with the integration step size h, in time units.
SelectionPolicy - Interface in org.apache.commons.math.genetics
Algorithm used to select a chromosome pair from a population.
selectionSort(double[]) - Static method in class flanagan.math.Fmath
 
selectionSort(float[]) - Static method in class flanagan.math.Fmath
 
selectionSort(int[]) - Static method in class flanagan.math.Fmath
 
selectionSort(long[]) - Static method in class flanagan.math.Fmath
 
selectionSort(double[], double[], int[]) - Static method in class flanagan.math.Fmath
 
selectionSort(double[], double[], double[], double[]) - Static method in class flanagan.math.Fmath
 
selectionSort(float[], float[], float[], float[]) - Static method in class flanagan.math.Fmath
 
selectionSort(long[], long[], long[], long[]) - Static method in class flanagan.math.Fmath
 
selectionSort(int[], int[], int[], int[]) - Static method in class flanagan.math.Fmath
 
selectionSort(double[], long[], double[], long[]) - Static method in class flanagan.math.Fmath
 
selectionSort(long[], double[], long[], double[]) - Static method in class flanagan.math.Fmath
 
selectionSort(double[], int[], double[], int[]) - Static method in class flanagan.math.Fmath
 
selectionSort(int[], double[], int[], double[]) - Static method in class flanagan.math.Fmath
 
selectionSort(long[], int[], long[], int[]) - Static method in class flanagan.math.Fmath
 
selectionSort(int[], long[], int[], long[]) - Static method in class flanagan.math.Fmath
 
selectPoints(int[], int) - Method in class umontreal.iro.lecuyer.hups.SubsetOfPointSet
Selects the numPoints points whose numbers are provided in the array pointIndices.
selectPointsRange(int, int) - Method in class umontreal.iro.lecuyer.hups.SubsetOfPointSet
Selects the points numbered from ``from'' to ``to - 1'' from the original point set.
selectRungeKutta2(double) - Static method in class umontreal.iro.lecuyer.simevents.Continuous
Selects a Runge-Kutta method of order 2 as the integration method to be used, with step size h.
selectRungeKutta2(double) - Method in class umontreal.iro.lecuyer.simevents.ContinuousState
Selects a Runge-Kutta method of order 2 as the integration method to be used, with step size h.
selectRungeKutta4(double) - Static method in class umontreal.iro.lecuyer.simevents.Continuous
Selects a Runge-Kutta method of order 4 as the integration method to be used, with step size h.
selectRungeKutta4(double) - Method in class umontreal.iro.lecuyer.simevents.ContinuousState
Selects a Runge-Kutta method of order 4 as the integration method to be used, with step size h.
selectSort(double[], double[], int[]) - Static method in class flanagan.math.Fmath
 
selectSortArrayList(double[]) - Static method in class flanagan.math.Fmath
 
selectSortVector(double[]) - Static method in class flanagan.math.Fmath
 
selfAnd(BitVector) - Method in class umontreal.iro.lecuyer.util.BitVector
Applies the and operator on this with that.
selfNot() - Method in class umontreal.iro.lecuyer.util.BitVector
Applies the not operator on the current BitVector and returns it.
selfOr(BitVector) - Method in class umontreal.iro.lecuyer.util.BitVector
Applies the or operator on this with that.
selfShift(int) - Method in class umontreal.iro.lecuyer.util.BitVector
Shift all the bits of the current BitVector j positions to the right if j is positive, and j positions to the left if j is negative.
selfXor(BitVector) - Method in class umontreal.iro.lecuyer.util.BitVector
Applies the xor operator on this with that.
seLocation(double, double) - Method in class jhplot.HMLabel
Sets the location of this label in data coordinates.
semiBandwidth(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Returns the semi-bandwidth of the given square matrix A.
semiBandwidth(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Returns the semi-bandwidth of the given square matrix A.
semiBandwidth(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Returns the semi-bandwidth of the given square matrix A.
semiBandwidth(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
Returns the semi-bandwidth of the given square matrix A.
semiBandwidth(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Returns the semi-bandwidth of the given square matrix A.
SemiVariance - Class in org.apache.commons.math.stat.descriptive.moment
Computes the semivariance of a set of values with respect to a given cutoff value.
SemiVariance() - Constructor for class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with default (true) biasCorrected property and default (Downside) varianceDirection property.
SemiVariance(boolean) - Constructor for class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with the specified biasCorrected property and default (Downside) varianceDirection property.
SemiVariance(SemiVariance.Direction) - Constructor for class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with the specified Direction property and default (true) biasCorrected property
SemiVariance(boolean, SemiVariance.Direction) - Constructor for class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Constructs a SemiVariance with the specified isBiasCorrected property and the specified Direction property.
SemiVariance(SemiVariance) - Constructor for class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Copy constructor, creates a new SemiVariance identical to the original
SemiVariance.Direction - Enum in org.apache.commons.math.stat.descriptive.moment
The direction of the semivariance - either upside or downside.
SeqBlas - Class in cern.colt.matrix.linalg
Sequential implementation of the Basic Linear Algebra System.
seqBlas - Static variable in class cern.colt.matrix.linalg.SeqBlas
Little trick to allow for "aliasing", that is, renaming this class.
Serialized - Class in jhplot.io
Methods used for serialization.
Serialized() - Constructor for class jhplot.io.Serialized
 
serializeRealMatrix(RealMatrix, ObjectOutputStream) - Static method in class org.apache.commons.math.linear.MatrixUtils
Serialize a RealMatrix.
serializeRealVector(RealVector, ObjectOutputStream) - Static method in class org.apache.commons.math.linear.MatrixUtils
Serialize a RealVector.
serialVersionUID - Static variable in class cern.colt.PersistentObject
 
serialVersionUID - Static variable in interface hep.aida.tdouble.DoubleIAxis
 
serialVersionUID - Static variable in interface hep.aida.tdouble.DoubleIHistogram
 
serialVersionUID - Static variable in interface hep.aida.tfloat.FloatIAxis
 
serialVersionUID - Static variable in interface hep.aida.tfloat.FloatIHistogram
 
Series - Class in jhplot.math.num
This class provides the means to evaluate infinite series (1).
servList() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Returns the list that contains the UserRecord objects for the processes in the service list for this resource.
set(int) - Method in class cern.colt.bitvector.BitVector
Changes the bit with index bitIndex to the "set" (true) state.
set(long[], int) - Static method in class cern.colt.bitvector.QuickBitVector
Changes the bit with index bitIndex in the bitvector bits to the "set" (true) state.
set(int, boolean) - Method in class cern.colt.list.AbstractBooleanList
Replaces the element at the specified position in the receiver with the specified element.
set(int, byte) - Method in class cern.colt.list.AbstractByteList
Replaces the element at the specified position in the receiver with the specified element.
set(int, char) - Method in class cern.colt.list.AbstractCharList
Replaces the element at the specified position in the receiver with the specified element.
set(int, double) - Method in class cern.colt.list.AbstractDoubleList
Replaces the element at the specified position in the receiver with the specified element.
set(int, float) - Method in class cern.colt.list.AbstractFloatList
Replaces the element at the specified position in the receiver with the specified element.
set(int, int) - Method in class cern.colt.list.AbstractIntList
Replaces the element at the specified position in the receiver with the specified element.
set(int, long) - Method in class cern.colt.list.AbstractLongList
Replaces the element at the specified position in the receiver with the specified element.
set(int, short) - Method in class cern.colt.list.AbstractShortList
Replaces the element at the specified position in the receiver with the specified element.
set(int, Object) - Method in class cern.colt.list.adapter.DoubleListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, Object) - Method in class cern.colt.list.adapter.FloatListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, Object) - Method in class cern.colt.list.adapter.IntListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, Object) - Method in class cern.colt.list.adapter.LongListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, Object) - Method in class cern.colt.list.adapter.ObjectListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, boolean) - Method in class cern.colt.list.BooleanArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, byte) - Method in class cern.colt.list.ByteArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, char) - Method in class cern.colt.list.CharArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, double) - Method in class cern.colt.list.DoubleArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, float) - Method in class cern.colt.list.FloatArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, int) - Method in class cern.colt.list.IntArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, long) - Method in class cern.colt.list.LongArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, Object) - Method in class cern.colt.list.ObjectArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, short) - Method in class cern.colt.list.ShortArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, boolean) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Replaces the element at the specified position in the receiver with the specified element.
set(int, boolean) - Method in class cern.colt.list.tboolean.BooleanArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, byte) - Method in class cern.colt.list.tbyte.AbstractByteList
Replaces the element at the specified position in the receiver with the specified element.
set(int, byte) - Method in class cern.colt.list.tbyte.ByteArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, char) - Method in class cern.colt.list.tchar.AbstractCharList
Replaces the element at the specified position in the receiver with the specified element.
set(int, char) - Method in class cern.colt.list.tchar.CharArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, double) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Replaces the element at the specified position in the receiver with the specified element.
set(int, double) - Method in class cern.colt.list.tdouble.DoubleArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, Object) - Method in class cern.colt.list.tdouble.DoubleListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, float) - Method in class cern.colt.list.tfloat.AbstractFloatList
Replaces the element at the specified position in the receiver with the specified element.
set(int, float) - Method in class cern.colt.list.tfloat.FloatArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, Object) - Method in class cern.colt.list.tfloat.FloatListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, int) - Method in class cern.colt.list.tint.AbstractIntList
Replaces the element at the specified position in the receiver with the specified element.
set(int, int) - Method in class cern.colt.list.tint.IntArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, Object) - Method in class cern.colt.list.tint.IntListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, long) - Method in class cern.colt.list.tlong.AbstractLongList
Replaces the element at the specified position in the receiver with the specified element.
set(int, long) - Method in class cern.colt.list.tlong.LongArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, Object) - Method in class cern.colt.list.tlong.LongListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, Object) - Method in class cern.colt.list.tobject.ObjectArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, Object) - Method in class cern.colt.list.tobject.ObjectListAdapter
Replaces the element at the specified position in this list with the specified element (optional operation).
set(int, short) - Method in class cern.colt.list.tshort.AbstractShortList
Replaces the element at the specified position in the receiver with the specified element.
set(int, short) - Method in class cern.colt.list.tshort.ShortArrayList
Replaces the element at the specified position in the receiver with the specified element.
set(int, double) - Method in class cern.colt.matrix.DoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, double) - Method in class cern.colt.matrix.DoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, double) - Method in class cern.colt.matrix.DoubleMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, Object) - Method in class cern.colt.matrix.ObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, Object) - Method in class cern.colt.matrix.ObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, Object) - Method in class cern.colt.matrix.ObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int) - Method in class cern.colt.matrix.tbit.BitVector
Changes the bit with index bitIndex to the "set" (true) state.
set(long[], int) - Static method in class cern.colt.matrix.tbit.QuickBitVector
Changes the bit with index bitIndex in the bitvector bits to the "set" (true) state.
set(int, double, double) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, float, float) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, float) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, float) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, float) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, long) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, long) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, long) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set(int, Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
set(int, int, Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
set(int, int, int, Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
set - Variable in class jhplot.HChart
 
set - Variable in class jhplot.HGraph
 
set - Variable in class jhplot.HPlot3D
 
set - Variable in class jhplot.HPlot3DP
 
set - Variable in class jhplot.HView3D
 
set(int, double) - Method in class jhplot.math.num.DoubleArray
Modify the element at the given index.
set(int, double) - Method in class jhplot.P0D
Sets a value at the specified position.
set(int, Integer) - Method in class jhplot.P0I
Sets a value at the specified position.
set(int, double, double) - Method in class jhplot.P1D
Sets the values of a plot-point pair (X,Y).
set(int, double, double, double, double) - Method in class jhplot.P1D
Sets the values of a plot-point pair (x,y).
set(int, double, double, double, double, double, double) - Method in class jhplot.P1D
Sets the values of a plot-point pair (x,y).
set(int, double, double, double, double, double, double, double, double, double, double) - Method in class jhplot.P1D
Sets the values of a plot-point pair (x,y).
set(int, double, double, double) - Method in class jhplot.P2D
Sets the values of (x,y,z).
set(int, double, double, double, double, double, double) - Method in class jhplot.P3D
Sets the values of (x,dx,y,dy,z,dz).
set(int, double[]) - Method in class jhplot.PND
Sets (replace) the specified row.
set(int, P0D) - Method in class jhplot.PND
Sets (replace) the specified element with P0D.
set(int, int[]) - Method in class jhplot.PNI
Sets (replace) the specified row.
set(int, P0I) - Method in class jhplot.PNI
Sets (replace) the specified element with P0D.
set(float, float, float) - Method in class jhplot.v3d.Vector3d
 
set(int, double, double, int) - Method in class jminhep.cluster.Partition
Set parameters for clustering
set(double) - Method in class org.apache.commons.math.linear.AbstractRealVector
Set all elements to a single value.
set(int, ArrayFieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Set a set of consecutive elements.
set(T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Set all elements to a single value.
set(int, ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Set a set of consecutive elements.
set(double) - Method in class org.apache.commons.math.linear.ArrayRealVector
Set all elements to a single value.
set(T) - Method in interface org.apache.commons.math.linear.FieldVector
Set all elements to a single value.
set(double) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Set all elements to a single value.
set(double) - Method in interface org.apache.commons.math.linear.RealVector
Set all elements to a single value.
set(T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Set all elements to a single value.
set(SSJXYSeriesCollection) - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Sets the primary dataset for the plot, replacing the existing dataset if there is one.
set(int, SSJXYSeriesCollection) - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Replaces the element at the specified position in the dataset list with the specified element.
set(int, E) - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
 
set(boolean) - Method in class umontreal.iro.lecuyer.simprocs.Condition
Sets the condition to val.
set(int, E) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
set(int, int, double) - Method in class umontreal.iro.lecuyer.util.DMatrix
Sets the value of the element in the specified row and column.
set(int, OE) - Method in class umontreal.iro.lecuyer.util.TransformingList
 
setAbsoluteAccuracy(double) - Method in interface org.apache.commons.math.ConvergingAlgorithm
Deprecated. Set the absolute accuracy.
setAbsoluteAccuracy(double) - Method in class org.apache.commons.math.ConvergingAlgorithmImpl
Deprecated. Set the absolute accuracy.
setAbsoluteAccuracy(double) - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Set the absolute accuracy.
setAbsoluteTolerance(double) - Method in class cern.colt.matrix.tdouble.algo.solver.DefaultDoubleIterationMonitor
Sets the absolute convergence tolerance
setAbsoluteTolerance(float) - Method in class cern.colt.matrix.tfloat.algo.solver.DefaultFloatIterationMonitor
Sets the absolute convergence tolerance
setActiveEuler(double, double, double) - Method in class hephysics.vec.Hep3Matrix
Defines a rotation matrix via Euler angles.
setAlignment(String) - Method in class cern.colt.matrix.AbstractFormatter
Sets the column alignment (left,center,right,decimal).
setAlignment(String) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the column alignment (left,center,right,decimal).
setAllign(int) - Method in class jhplot.jadraw.JaLatexText
Sets the allign property of this text object.
setAlpha(double) - Method in class jhplot.math.num.pdf.Beta
Modify the alpha parameter.
setAlpha(double) - Method in class jhplot.math.num.pdf.Gamma
Modify the alpha parameter.
setAlpha(double) - Method in interface org.apache.commons.math.distribution.BetaDistribution
Deprecated. as of 2.1
setAlpha(double) - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setAlpha(double) - Method in interface org.apache.commons.math.distribution.GammaDistribution
Deprecated. as of v2.1
setAlpha(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setAlphaBeta(double, double) - Method in class jhplot.bsom.BsomDemo
Set alpha and beta for learning
setAlphaBeta(double, double) - Method in class jhplot.HBsom
Set initial alpha and betai parameters.
setAmp(int) - Method in class jhplot.jadraw.JaArcObject
Sets the amp property of this arc object.
setAmp(int) - Method in class jhplot.jadraw.JaLineObject
Sets the amp property of this line object.
setAmp(int) - Method in class jhplot.jadraw.JaLoopObject
Sets the amp property of this loop object.
setAngamp(int) - Method in class jhplot.jadraw.JaGlLine
Sets the angamp property of this JaGlLine.
setAnnotation(IAnnotation) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setAnnotation(IAnnotation) - Method in class hep.aida.ref.histogram.AbstractBaseHistogram
 
setAnnotation(IAnnotation) - Method in class hep.aida.ref.histogram.DataPointSet
 
setAnnotation(IAnnotation) - Method in class hep.aida.ref.tuple.AbstractTuple
 
setAntiAlias(boolean) - Method in class jhplot.HPlot
Set antialiasing for the graphics of the current plot
setAntiAlias(boolean) - Method in class jhplot.HPlotJa
Set antialiasing for the graphics of the current plot
setAntiAliasAll(boolean) - Method in class jhplot.HPlot
Set antialiasing for the graphics of all plots
setAntithetic(boolean) - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated.  
setArcPts(int, int, int, int, int, int) - Method in class jhplot.jadraw.JaArcObject
Sets the points of this arc.
setArity(int) - Method in class org.apache.commons.math.genetics.TournamentSelection
Sets the arity (number of chromosomes drawn to the tournament).
setArray(double[]) - Method in class jhplot.P0D
Set a double array.
setArray(int[]) - Method in class jhplot.P0D
Set an integer array.
setArray(Integer[]) - Method in class jhplot.P0I
Set a Integer array.
setArray(int[]) - Method in class jhplot.P0I
Set an integer array.
setArray(double[][]) - Method in class jhplot.PND
Set values from double array Old content will be lost.
setArray(int[][]) - Method in class jhplot.PNI
Set values from double array Old content will be lost.
setArrayList(ArrayList<Double>) - Method in class jhplot.P0D
Set the data in form of ArrayList
setArrayList(ArrayList<Integer>) - Method in class jhplot.P0I
Set the data in form of ArrayList
setArrayList(ArrayList<double[]>) - Method in class jhplot.PND
Set the data in form of ArrayList
setArrayList(ArrayList<int[]>) - Method in class jhplot.PNI
Set the data in form of ArrayList
setArrow(boolean) - Method in class jhplot.jadraw.JaArcObject
Sets the arrow property of this arc object.
setArrow(boolean) - Method in class jhplot.jadraw.JaLineObject
Sets the arrow property of this line object.
setArrow(boolean) - Method in class jhplot.jadraw.JaLoopObject
Sets the arrow property of this loop object.
setAsMarked(boolean) - Method in class jhplot.jadraw.JaObject
Sets this JaObject as element of a group.
setAttResizable(boolean) - Method in class jhplot.HPlot
Set canvas attributes resizable (line widths, symbols, fonts) or not.
setAttResizableAll(boolean) - Method in class jhplot.HPlot
Set canvas attributes resizable (line widths, symbols, fonts) or not.
setAutoRange(boolean) - Method in class jhplot.HChart
Set auto-range in X and Y at the same time
setAutoRange() - Method in class jhplot.HChart
Set autorange in X and Y at the same time
setAutoRange(int, boolean) - Method in class jhplot.HPlot
Sets true or false to use automatic scaling for the current plot.
setAutoRange(boolean) - Method in class jhplot.HPlot
Set autorange in X and Y at the same time
setAutoRange() - Method in class jhplot.HPlot
Set autorange in X and Y at the same time for the current plot
setAutoRange() - Method in class jhplot.HPlot2D
Set autorange for the current plot
setAutoRange(boolean) - Method in class jhplot.HPlot2D
Set autorange or not for the current plot
setAutoRange(int, boolean) - Method in class jhplot.HPlot2D
Set autorange for the current plot
setAutoRange(boolean) - Method in class jhplot.HPlot3D
Set autorange in X,Y,Z.
setAutoRange() - Method in class jhplot.HPlot3D
Set autorange in X,Y,Z at the same time for the current plot
setAutoRange(int, boolean) - Method in class jhplot.HPlotJa
Sets true or false to use automatic scaling for the current plot.
setAutoRange(boolean) - Method in class jhplot.HPlotJa
Set autorange in X and Y at the same time
setAutoRange() - Method in class jhplot.HPlotJa
Set autorange in X and Y at the same time for the current plot
setAutoRange(int, boolean) - Method in class jhplot.jadraw.JaAxes
Set autorange for a particular axis
setAutoRange() - Method in class jhplot.jadraw.JaAxes
Set auto-range on all axes
setAutoRange() - Method in class jhplot.SPlot
Rescale so that the data that is currently plotted just fits.
setAutoRange(boolean) - Method in class jhplot.SPlot
Rescale so that the data that is currently plotted just fits.
setAutoRange() - Method in class umontreal.iro.lecuyer.charts.CategoryChart
Sets chart y range to automatic values.
setAutoRange(boolean, boolean) - Method in class umontreal.iro.lecuyer.charts.HistogramChart
 
setAutoRange() - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Sets chart range to automatic values.
setAutoRange() - Method in class umontreal.iro.lecuyer.charts.XYChart
The x and the y ranges of the chart are set automatically.
setAutoRange(boolean, boolean) - Method in class umontreal.iro.lecuyer.charts.XYChart
The x and the y ranges of the chart are set automatically.
setAutoRange00(boolean, boolean) - Method in class umontreal.iro.lecuyer.charts.XYChart
The x and the y ranges of the chart are set automatically.
setAutoRangeAll(int, boolean) - Method in class jhplot.HPlot
Sets true or false to use automatic scaling for all plots.
setAutoRangeAll(boolean) - Method in class jhplot.HPlot
Set auto-range in X and Y at the same time for all plots
setAutoRangeAll() - Method in class jhplot.HPlot
Set autorange in X and Y at the same time for all plots
setAutoRangeAll() - Method in class jhplot.HPlot2D
Set autorange in X and Y at the same time for all plots
setAutoRangeAll(boolean) - Method in class jhplot.HPlot3D
Set to autorange all pads
setAutoRangeAll(int, boolean) - Method in class jhplot.HPlotJa
Sets true or false to use automatic scaling for all plots.
setAutoRangeAll(boolean) - Method in class jhplot.HPlotJa
Set auto-range in X and Y at the same time for all plots
setAutoRangeAll() - Method in class jhplot.HPlotJa
Set autorange in X and Y at the same time for all plots
setAutoRangeXY() - Method in class jhplot.HPlot3D
Set autorange in Y,Z at the same time for the current plot
setAvailableFonts(String[]) - Method in class jhplot.jadraw.JaKey
Sets the string array of available fonts.
setAvailableFonts(String[]) - Method in class jhplot.jadraw.JaText
Sets the string array of available fonts.
setAxes(boolean) - Method in class jhplot.HPlot3DP
Set all axes or not
setAxes(boolean, boolean, boolean) - Method in class jhplot.HPlot3DP
Show or not axes for X, Y, Z
setAxesArrow(int, int) - Method in class jhplot.jadraw.JaAxes
Set arrow type
setAxesArrows(boolean) - Method in class jhplot.HPlot3DP
Show or not small arrows on axes
setAxesColor(Color) - Method in class jhplot.HPlot
Sets the actual color of the axes of the graph.
setAxesColor(Color) - Method in class jhplot.HPlot3DP
Set Color for axes
setAxesFontColor(Color) - Method in class jhplot.HPlot3D
Get color for tic labels
setAxesFrame(int, int) - Method in class jhplot.HPlotJa
Set axes frames or pads.
setAxesRatio(double) - Method in class jhplot.HPlot
Sets the ratio between X- and Y-axes lengths.
setAxesRatioUse(boolean) - Method in class jhplot.HPlot
Sets whether or not to use a fixed ratio between X- and Y-axes lengths.
setAxis(int, boolean) - Method in class jhplot.HPlot
Sets whether an axis line will be drawn or not.
setAxis(int, Axis) - Method in class jhplot.HPlot2D
Set axis objects
setAxis(int, boolean) - Method in class jhplot.HPlot2D
Sets whether an axis line will be drawn or not.
setAxis(boolean) - Method in class jhplot.HZirkel
Show coordinate system on the canvas.
setAxisAll(boolean) - Method in class jhplot.HPlot
Sets whether all axis lines will be drawn or not.
setAxisAll(boolean) - Method in class jhplot.HPlotJa
Sets whether all axis lines will be drawn or not.
setAxisArrow(int) - Method in class jhplot.HPlot
Sets axes arrows.
setAxisArrows(boolean) - Method in class jhplot.HPlot3DP
Set or not arrows for axis
setAxisFont(Font) - Method in class jhplot.HPlot3D
Sets font for axes
setAxisLabelColor(Color) - Method in class jhplot.HPlot2D
Sets the pen color for ticks
setAxisLabelFont(Font) - Method in class jhplot.HPlot2D
Set fonts for axis Label
setAxisLabelPosition(int, int) - Method in class jhplot.HPlot2D
Position of label for axis
setAxisMirror(int, boolean) - Method in class jhplot.HPlot
Sets whether the mirror of an axis will be drawn or not.
setAxisNumberSubtics(int) - Method in class jhplot.HPlot2D
Sets the number of small sub-ticks
setAxisPenTicWidth(int) - Method in class jhplot.HPlot
Sets the pen width to draw tick axes.
setAxisPenTicWidth(int) - Method in class jhplot.HPlot2D
Sets the pen width to draw tick axes
setAxisTicHeight(int) - Method in class jhplot.HPlot2D
Sets the tick heights in NDC units
setAxisTitle(int, SGLabel) - Method in class jhplot.HPlot2D
Set label for axis
setAxisX() - Method in class jhplot.HPlot
Sets X-axis (bottom).
setAxisY() - Method in class jhplot.HPlot
Sets Y-axis (left).
setBack(boolean) - Method in class jhplot.jadraw.JaLineObject
Sets the back property of this line object.
setBack(double) - Method in class jhpro.stat.limit.ExpData
Set background number
setBackgColor(Color) - Method in class jhplot.HPlot
Sets the actual background color of the entire graph panel.
setBackgColor(Color) - Method in class jhplot.HPlot3DP
Set background for current pad
setBackgColorForAllGraph(Color) - Method in class jhplot.HPlot
Sets the background color of all graphs.
setBackgColorGraph(Color) - Method in class jhplot.HPlot
Sets the background color of the current graph.
setBackground(Color) - Method in class jhplot.HPlot2D
Set background for the plot.
setBackground(Color) - Method in class jhplot.SPlot
Set background for the plot.
setBandwidth(double) - Method in class umontreal.iro.lecuyer.randvar.KernelDensityGen
Sets the bandwidth to h.
setBandwidth(double) - Method in class umontreal.iro.lecuyer.randvar.KernelDensityVarCorrectGen
 
setBars(boolean) - Method in class jhplot.DrawOptions
Draw a histogram using bars (default is using lines).
setBars() - Method in class jhplot.HPlot3D
Set bar type of plot
setBars(boolean) - Method in class jhplot.HPlot3D
Set bar type of plot
setBars(boolean) - Method in class jhplot.SPlot
Turn bars on or off (for bar charts).
setBars(double, double) - Method in class jhplot.SPlot
Turn bars on and set the width and offset.
setBartlett() - Method in class flanagan.math.FourierTransform
 
setBeta(double) - Method in class jhplot.math.num.pdf.Beta
Modify the beta parameter.
setBeta(double) - Method in class jhplot.math.num.pdf.Gamma
Modify the beta parameter.
setBeta(double) - Method in interface org.apache.commons.math.distribution.BetaDistribution
Deprecated. as of 2.1
setBeta(double) - Method in class org.apache.commons.math.distribution.BetaDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setBeta(double) - Method in interface org.apache.commons.math.distribution.GammaDistribution
Deprecated. as of v2.1
setBeta(double) - Method in class org.apache.commons.math.distribution.GammaDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setBiasCorrected(boolean) - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Sets the biasCorrected property.
setBiasCorrected(boolean) - Method in class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
 
setBiasCorrected(boolean) - Method in class org.apache.commons.math.stat.descriptive.moment.Variance
 
setBinCenter(int, double) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
This method sets new center of the bin and initializes other bin data
setBinCenter(int, double) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner1D
 
setBinContent(int[], int, double, double[], double[]) - Method in interface hep.aida.ref.dataset.binner.Binner
Set at once the content of a bin.
setBinContent(int[], int, double, double[], double[]) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Set at once the content of a bin.
setBinContent(int[], int, double, double[], double[]) - Method in class hep.aida.ref.dataset.binner.EfficiencyBinner
Set at once the content of a bin.
setBinContent(int, double, int, double, double, double, double, double, double) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
setBinContent(int, int, int, double, double, double, double, double, double, double) - Method in class hep.aida.ref.histogram.binner.BasicBinner2D
 
setBinContent(int, int, int, int, double, double, double, double, double, double, double, double, double) - Method in class hep.aida.ref.histogram.binner.BasicBinner3D
 
setBinContent(int, double, int, double, double, double, double, double, double) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
setBinContent(int, int, int, double, double, double, double, double, double, double) - Method in interface hep.aida.ref.histogram.binner.Binner2D
 
setBinContent(int, int, int, int, double, double, double, double, double, double, double, double, double) - Method in interface hep.aida.ref.histogram.binner.Binner3D
 
setBinContent(int, int, double, double, double, double, double, double) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner1D
 
setBinContent(int, int, int, double, double, double, double, double, double, double) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner2D
 
setBinContent(int, int, int, int, double, double, double, double, double, double, double, double, double) - Method in class hep.aida.ref.histogram.binner.EfficiencyBinner3D
 
setBinError(BinError) - Method in class hep.aida.ref.dataset.binner.DefaultBinner
Set the BinError with which the plus and minus error on the bin are calculated.
setBinError(int, int, double) - Method in class hep.aida.ref.histogram.Histogram2D
Set the error on this bin.
setBinError(int, int, int, double) - Method in class hep.aida.ref.histogram.Histogram3D
Set the error on this bin.
setBinError(int, int, double) - Method in class jhplot.H2D
Set the error on this bin.
setBins(int) - Method in class jhplot.H1D
Sets the number of bins
setBins(int) - Method in class jhplot.HProf1D
Sets the number of bins
setBins(int, int) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Sets the bins for a series.
setBins(int, int, double, double) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Sets the bins for a series.
setBins(int, HistogramBin[]) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Sets the bins for a series.
setBins(int, int) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Sets bins periodic bins from the observation minimum values to the observation maximum value for a series.
setBins(int, int, double, double) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Sets bins periodic bins from minimum to maximum for a series.
setBins(int, HistogramBin[]) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Links bins given by table binsTable to a series.
setBinWidth(double) - Method in class jhplot.DrawOptions
Set the bin width.
setBool(int, int, boolean) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Changes the value of the bit in the specified row and column.
setBool(int, boolean) - Method in class umontreal.iro.lecuyer.util.BitVector
Sets the value of the bit in position pos.
setBound(boolean) - Method in class org.apache.commons.math.estimation.EstimatedParameter
Deprecated. Set the bound flag of the parameter
setBoundingBox(double[]) - Method in class jhplot.jadraw.JaObject
Sets the bounding box of this JaObject.
setBounds(double, double) - Method in class hep.aida.ref.fitter.FitParameterSettings
 
setBounds(int, int, int, int) - Method in class jhplot.SPlot
Move and resize this component.
setBox(boolean) - Method in class jhplot.HPlot
Sets whether or not to draw the bounding box around the graph.
setBoxColor(Color) - Method in class jhplot.HPlot
Sets the color of the bounding box drawn around a graph.
setBoxColor(Color) - Method in class jhplot.HPlot3D
Set color of the box
setBoxed(boolean) - Method in class jhplot.HPlot3D
Set boxed frame
setBoxes(int) - Method in class hep.aida.ref.function.Grid
 
setBoxFillColor(Color) - Method in class jhplot.HPlot
Sets the fill color of the bounding box drawn around a graph.
setBoxOffset(double) - Method in class jhplot.HPlot
Sets the offset of the bounding box drawn around a graph.
setBrightnessExponent(int) - Method in class org.apache.commons.math.analysis.interpolation.MicrosphereInterpolator
Set the brightness exponent.
setBroadcasting(boolean) - Method in class umontreal.iro.lecuyer.simprocs.Condition
Instructs the condition to start or stop observation broadcasting.
setBroadcasting(boolean) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Sets the status of the observation broadcasting mechanism to b.
setBroadcasting(boolean) - Method in class umontreal.iro.lecuyer.stat.StatProbe
Instructs the probe to turn its broadcasting ON or OFF.
setBrownianMotionPCA(BrownianMotionPCA) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessPCA
Sets the brownian motion PCA.
setBtot(double) - Method in class jhpro.stat.ConfidenceLevel
 
setCachedGen(RandomVariateGen) - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Sets the random variate generator whose values are cached to rvg.
setCachedStream(RandomStream) - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Sets the random stream whose values are cached to stream.
setCachedValues(DoubleArrayList) - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Sets the array list containing the cached values to values.
setCachedValues(DoubleArrayList) - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Sets the array list containing the cached values to values.
setCacheIndex(int) - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Sets the index, in the cache, of the next value returned by nextDouble.
setCacheIndex(int) - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Sets the index, in the cache, of the next value returned by nextDouble.
setCaching(boolean) - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGenWithCache
Sets the caching indicator to caching.
setCaching(boolean) - Method in class umontreal.iro.lecuyer.rng.RandomStreamWithCache
Sets the caching indicator to caching.
setCameraPosition(double) - Method in class jhplot.HPlot3DP
Set camera position
setCapacity(int) - Method in class umontreal.iro.lecuyer.simprocs.Resource
Sets the capacity to newcap.
setCellAt(Object, int, int) - Method in class jhplot.SPsheet
This fill assumes that the object passes to it is already the correct object to set the value of the cell as.
setCellSize(int) - Method in class jhplot.HCellular
Set cell size
setCharge(double) - Method in class hephysics.particle.LParticle
Set charge
setChargeParity(float) - Method in class hephysics.particle.HEParticle
Set C charge conjugation parity
setChartArea() - Method in class jhplot.HChart
Make an Area chart.
setChartBar() - Method in class jhplot.HChart
Make a Bar chart.
setChartBar3D() - Method in class jhplot.HChart
Make a Bar chart in 3D.
setChartHistogram() - Method in class jhplot.HChart
Make a Histogram chart
setChartLine() - Method in class jhplot.HChart
Make a line chart.
setChartMargin(double) - Method in class umontreal.iro.lecuyer.charts.XYChart
Sets the chart margin to margin.
setChartPie() - Method in class jhplot.HChart
Make a Pie chart.
setChartPie3D() - Method in class jhplot.HChart
Make a Pie 3D chart.
setChartXY() - Method in class jhplot.HChart
Make a X-Y chart with data points (assuming no errors).
setChiSquareTest(TTest) - Static method in class org.apache.commons.math.stat.inference.TestUtils
Deprecated. 2.2 will be removed in 3.0 - not compatible with use from multiple threads
setChiSquareTest(ChiSquareTest) - Static method in class org.apache.commons.math.stat.inference.TestUtils
Deprecated. 2.2 will be removed in 3.0 - not compatible with use from multiple threads
setChromosomes(List<Chromosome>) - Method in class org.apache.commons.math.genetics.ListPopulation
Sets the list of chromosomes.
setCodeletString(String) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setCodeletString(String) - Method in class hep.aida.ref.function.AbstractIFunction
 
setCodeletString(String) - Method in class hep.aida.ref.function.BaseModelFunction
 
setCoefficients(double...) - Method in class umontreal.iro.lecuyer.functions.Polynomial
Sets the array of coefficients of this polynomial to coeff.
setCollecting(boolean) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Sets the status of the statistical collecting mechanism to c.
setCollecting(boolean) - Method in class umontreal.iro.lecuyer.stat.StatProbe
Turns ON or OFF the collection of statistical observations.
setColor(Color) - Method in class jhplot.DrawOptions
Set color for lines
setColor(Color) - Method in class jhplot.HKey
Sets the color to a specific value
setColor(Color) - Method in class jhplot.HLabel
Sets the color to a specific value
setColor(Color) - Method in class jhplot.HLabelEq
Sets the color to a specific value
setColor(Color) - Method in class jhplot.HMLabel
Sets the color to a specific value
setColor(Color) - Method in class jhplot.jadraw.JaObject
Sets the color of this object.
setColor(Color) - Method in class jhplot.shapes.HShape
Sets the color to a specific value
setColor(boolean) - Method in class jhplot.SPlot
If the argument is false, draw the plot without using color (in black and white).
setColor(Color) - Method in class jhplot.v3d.Object3d
 
setColor(int, int, int) - Method in class jhplot.v3d.Object3d
 
setColor(int, Color) - Method in class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
Sets a new plotting color to the series series.
setColor(int, Color) - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Sets a new plotting color to the series series.
setColorBack(Color) - Method in class jhplot.v3d.Canvas3d
 
setColorBackgroud(Color) - Method in class jhplot.HLabelEq
Set background color
setColorBar(ColorKey) - Method in class jhplot.HPlot2D
Set color bar (key) for the current plot
setColorFill(Color) - Method in class jhplot.HPlot3D
Set color of to fill histogram bars
setColorLines(Color) - Method in class jhplot.HPlot3D
Set color of the lines to draw histogram bars
setColorMode(int) - Method in class jhplot.HPlot3D
Sets the color mode
setColors(Color[]) - Method in class jhplot.SPlot
Set the point colors.
setColumn(int, T[]) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Sets the entries in column number column as a column matrix.
setColumn(int, double[]) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Sets the entries in column number column as a column matrix.
setColumn(int, T[]) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Sets the entries in column number column as a column matrix.
setColumn(int, double[]) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Sets the entries in column number column as a column matrix.
setColumn(int, T[]) - Method in interface org.apache.commons.math.linear.FieldMatrix
Sets the entries in column number column as a column matrix.
setColumn(int, double[]) - Method in interface org.apache.commons.math.linear.RealMatrix
Sets the entries in column number column as a column matrix.
setColumnMapping(String[]) - Method in class jhplot.io.csv.bean.ColumnPositionMappingStrategy
 
setColumnMapping(Map) - Method in class jhplot.io.csv.bean.HeaderColumnNameTranslateMappingStrategy
 
setColumnMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Sets the entries in column number column as a column matrix.
setColumnMatrix(int, RealMatrix) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Sets the entries in column number column as a column matrix.
setColumnMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Sets the entries in column number column as a column matrix.
setColumnMatrix(int, RealMatrix) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Sets the entries in column number column as a column matrix.
setColumnMatrix(int, FieldMatrix<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Sets the entries in column number column as a column matrix.
setColumnMatrix(int, RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Sets the entries in column number column as a column matrix.
setColumnSeparator(String) - Method in class cern.colt.matrix.AbstractFormatter
Sets the string separating any two columns from another.
setColumnSeparator(String) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the string separating any two columns from another.
setColumnVector(int, FieldVector<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Sets the entries in column number column as a vector.
setColumnVector(int, RealVector) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Sets the entries in column number column as a vector.
setColumnVector(int, FieldVector<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Sets the entries in column number column as a vector.
setColumnVector(int, RealVector) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Sets the entries in column number column as a vector.
setColumnVector(int, FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Sets the entries in column number column as a vector.
setColumnVector(int, RealVector) - Method in interface org.apache.commons.math.linear.RealMatrix
Sets the entries in column number column as a vector.
setComplex() - Method in class jhplot.FND
Treat the function as complex.
setConfidenceIntervalNone() - Method in class umontreal.iro.lecuyer.stat.Tally
Indicates that no confidence interval needs to be printed in reports formatted by report, and shortReport.
setConfidenceIntervalNormal() - Method in class umontreal.iro.lecuyer.stat.Tally
Indicates that a confidence interval on the true mean, based on the central limit theorem, needs to be included in reports formatted by report and shortReport.
setConfidenceIntervalStudent() - Method in class umontreal.iro.lecuyer.stat.Tally
Indicates that a confidence interval on the true mean, based on the normality assumption, needs to be included in reports formatted by report and shortReport.
setConfidenceLevel(double) - Method in class umontreal.iro.lecuyer.stat.Tally
Sets the level of confidence for the intervals on the mean displayed in reports.
setConnected(boolean) - Method in class hep.aida.ref.event.AIDAObservable
 
setConnected(boolean) - Method in interface hep.aida.ref.event.Connectable
 
setConnected(boolean) - Method in class hep.aida.ref.event.ConnectEvent
 
setConnected(boolean, int) - Method in class jhplot.SPlot
If the first argument is true, then by default for the specified dataset, points will be connected by a line.
setConstraint(String) - Method in class hep.aida.ref.fitter.Fitter
 
setConstraintMethod(int) - Method in class flanagan.math.Maximisation
 
setConstraintMethod(int) - Method in class flanagan.math.Minimisation
 
setConstraints(String[]) - Method in class hep.aida.ref.fitter.FitResult
 
setConstraintTolerance(double) - Method in class flanagan.analysis.Regression
 
setConstraintTolerance(double) - Method in class flanagan.math.Maximisation
 
setConstraintTolerance(double) - Method in class flanagan.math.Minimisation
 
setContents(double[], double[], int[], double[], double[]) - Method in class hep.aida.ref.histogram.Histogram1D
Set the content of the whole Histogram at once.
setContents(double[], double[], double[], int[], double[], double[], double[]) - Method in class hep.aida.ref.histogram.Histogram1D
 
setContents(double[][], double[][], int[][], double[][], double[][], double[][], double[][]) - Method in class hep.aida.ref.histogram.Histogram2D
Set the content of the whole Histogram at once.
setContents(double[][][], double[][][], int[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][]) - Method in class hep.aida.ref.histogram.Histogram3D
Set the content of the whole Histogram at once.
setContents(double[], double[], int[], double[], double[]) - Method in class hep.aida.ref.histogram.Profile1D
Set the content of the whole Histogram at once.
setContents(double[][], double[][], int[][], double[][], double[][], double[][]) - Method in class hep.aida.ref.histogram.Profile2D
 
setContents(DoubleHistogram1DContents) - Method in class hep.aida.tdouble.ref.DoubleHistogram1D
Sets the contents of this histogram.
setContents(FloatHistogram1DContents) - Method in class hep.aida.tfloat.ref.FloatHistogram1D
Sets the contents of this histogram
setContents(double[], double[]) - Method in class jhplot.H1D
Sets the content of H1D histogram.
setContents(double[], double[], int[], double[], double[]) - Method in class jhplot.H1D
Set the content of the whole Histogram at once.
setContents(double[][], double[][]) - Method in class jhplot.H2D
Set content of H2D histogram
setContents(double[][], double[][], int[][], double[][], double[][], double[][], double[][]) - Method in class jhplot.H2D
Set the content of the whole Histogram at once.
setContents(double[], double[]) - Method in class jhplot.HProf1D
Sets the content of histogram.
setContents(double[], double[], int[], double[], double[]) - Method in class jhplot.HProf1D
Set the content of the whole Histogram at once.
setContents(double[][], double[][]) - Method in class jhplot.HProf2D
Set content of H2D histogram
setContour(boolean) - Method in class jhplot.HPlot
Set to a contour style
setContour() - Method in class jhplot.HPlot3D
Set contour style
setContour(boolean) - Method in class jhplot.HPlot3D
Set contour style
setContour(boolean) - Method in class jhplot.HPlotJa
Set to a contour style
setContour(boolean) - Method in class jhplot.jadraw.JaAxes
Set the contour style and parse the data.
setContourBar(boolean) - Method in class jhplot.HPlot
Show or not a bar with color levels
setContourBar(boolean) - Method in class jhplot.HPlotJa
Show a bar indicating levels on contour plot
setContourBar(boolean) - Method in class jhplot.jadraw.JaAxes
Show or not a bar with color levels
setContourBins(int, int) - Method in class jhplot.HPlot
How many bins used to slice the data in X (and Y)
setContourBins(int, int) - Method in class jhplot.HPlotJa
Set number of contour bins in X and Y
setContourBins(int, int) - Method in class jhplot.jadraw.JaAxes
How many bins used to slice the data in X (and Y)
setContourGray(boolean) - Method in class jhplot.HPlot
Color style to show contour plot.
setContourGray(boolean) - Method in class jhplot.jadraw.JaAxes
Color style to show contour plot.
setContourLevels(int) - Method in class jhplot.HPlot
How many color levels shuul be shown (10 default)
setContourLevels(int) - Method in class jhplot.HPlotJa
Number of contour levels
setContourLevels(int) - Method in class jhplot.jadraw.JaAxes
How many color levels should be shown (10 default)
setContourLines(int) - Method in class jhplot.HPlot3D
Set number of divisions for contour plots
setContractionCriteria(float) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Sets the contraction criteria for this ExpandContractDoubleArray.
setConvergence(double) - Method in class org.apache.commons.math.estimation.GaussNewtonEstimator
Deprecated. Set the convergence criterion threshold.
setConvergenceChecker(RealConvergenceChecker) - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
Set the convergence checker.
setConvergenceChecker(VectorialConvergenceChecker) - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
Set the convergence checker.
setConvergenceChecker(RealConvergenceChecker) - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Set the convergence checker.
setConvergenceChecker(VectorialConvergenceChecker) - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Set the convergence checker.
setConvergenceChecker(RealConvergenceChecker) - Method in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Set the convergence checker.
setConvergenceChecker(RealConvergenceChecker) - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Set the convergence checker.
setConvergenceChecker(VectorialConvergenceChecker) - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Set the convergence checker.
setConvergenceChecker(RealConvergenceChecker) - Method in class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Set the convergence checker.
setConvergenceChecker(RealConvergenceChecker) - Method in interface org.apache.commons.math.optimization.MultivariateRealOptimizer
Set the convergence checker.
setConversionParameters(int, double, double) - Method in class hep.aida.ref.histogram.Cloud1D
Set the parameters for the ICloud conversion to an IHistogram.
setConversionParameters(int, double, double, int, double, double) - Method in class hep.aida.ref.histogram.Cloud2D
Set the parameters for the ICloud conversion to an IHistogram.
setConversionParameters(int, double, double, int, double, double, int, double, double) - Method in class hep.aida.ref.histogram.Cloud3D
Set the parameters for the ICloud conversion to an IHistogram.
setCoordinate(int, double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSet
 
setCoordinate(int, double[], double[], double[]) - Method in class hep.aida.ref.histogram.DataPointSet
 
setCorrelationObject(Object) - Method in class hep.aida.ref.fitter.fitmethod.AbstractFitMethod
 
setCostRelativeTolerance(double) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Deprecated. Set the desired relative error in the sum of squares.
setCostRelativeTolerance(double) - Method in class org.apache.commons.math.optimization.general.LevenbergMarquardtOptimizer
Set the desired relative error in the sum of squares.
setCovMatrixElement(int, int, double) - Method in class hep.aida.ref.fitter.FitResult
 
setCurCoordIndex(int) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
setCurCoordIndex(int) - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Sets the current coordinate index to j, so that the next calls to nextCoordinate or nextCoordinates will return the values ui, j, ui, j+1,..., where i is the index of the current point.
setCurDir(String) - Static method in class jhplot.HPlotJa
Sets the current working directory.
setCurPointIndex(int) - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet.CycleBasedPointSetIterator
 
setCurPointIndex(int) - Method in interface umontreal.iro.lecuyer.hups.PointSetIterator
Resets the current point index to i and the current coordinate index to zero.
setDash(float) - Method in class jhplot.jadraw.JaArcObject
Sets the dash property of this arc object.
setDash(float) - Method in class jhplot.jadraw.JaLineObject
Sets the dash property of this line object.
setDash(float) - Method in class jhplot.jadraw.JaLoopObject
Sets the dash property of this loop object.
setDashed(double) - Method in class jhplot.shapes.HShape
Set dashed line
setDashPattern(int, String) - Method in class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Selects dash pattern for a data series.
setDashPattern(int, String) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Selects dash pattern for a data series.
setData(double[]) - Method in class flanagan.math.FourierTransform
 
setData(Complex[]) - Method in class flanagan.math.FourierTransform
 
setData(P1D) - Method in class jhplot.HBsom
Load data to BSOM
setData(double[][], double[][]) - Method in class jhplot.HNeuralNet
Construct a data set from an input and idea array.
setData(double[][]) - Method in class jhplot.HNeuralNet
Construct a data set from an input
setData(PND, PND) - Method in class jhplot.HNeuralNet
Set data for training.
setData(PND) - Method in class jhplot.HNeuralNet
Set data
setData() - Method in class jhplot.HPlot2D
 
setData(Vector<DataArray>) - Method in class jhplot.jadraw.JaAxes
Set data in form of vector
setData(double[]) - Method in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
Set the data array.
setData(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.AbstractUnivariateStatistic
Set the data array.
setData(double[]) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Set the data array.
setData(double[], int, int) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Set the data array.
setDataArray(DataArray) - Method in class jhplot.P1D
Set data in a form of DataArray
setDataArray(DataArray2D) - Method in class jhplot.P2D
Set data in a form of DataArray
setDataArray(DataArray3D) - Method in class jhplot.P3D
Set data in a form of DataArray
setDataDescription(String) - Method in class hep.aida.ref.fitter.FitResult
 
setDataPers(DataArray) - Method in class jhplot.HPlot
Sets the data in the form DataArray data
setDefault() - Method in class jhplot.GHMargin
Set the default location
setDefault(Object) - Method in class jhplot.GHMargin
Set the default location
setDefault() - Method in class jhplot.HCellular
Set default parameters
setDegreesOfFreedom(double) - Method in class jhplot.math.num.pdf.ChiSquared
Modify the degrees of freedom.
setDegreesOfFreedom(double) - Method in class jhplot.math.num.pdf.TDistribution
Modify the degrees of freedom.
setDegreesOfFreedom(double) - Method in interface org.apache.commons.math.distribution.ChiSquaredDistribution
Deprecated. as of v2.1
setDegreesOfFreedom(double) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setDegreesOfFreedom(double) - Method in interface org.apache.commons.math.distribution.TDistribution
Deprecated. as of v2.1
setDegreesOfFreedom(double) - Method in class org.apache.commons.math.distribution.TDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setDelta(double) - Method in class flanagan.analysis.Regression
 
setDelta(double) - Method in class jhplot.bsom.Bsom
 
setDelta(double) - Method in class jhplot.HBsom
Set calculation precision.
setDeltaT(double) - Method in class flanagan.math.FourierTransform
 
setDenominatorDegreesOfFreedom(double) - Method in class jhplot.math.num.pdf.FDistribution
Modify the denominator degrees of freedom.
setDenominatorDegreesOfFreedom(double) - Method in interface org.apache.commons.math.distribution.FDistribution
Deprecated. as of v2.1
setDenominatorDegreesOfFreedom(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setDenominatorFormat(NumberFormat) - Method in class org.apache.commons.math.fraction.AbstractFormat
Modify the denominator format.
setDenominatorToN() - Method in class flanagan.analysis.BoxCox
 
setDenominatorToN() - Method in class flanagan.analysis.ProbabilityPlot
 
setDenominatorToN() - Static method in class flanagan.analysis.Regression
 
setDenominatorToN() - Method in class flanagan.analysis.Scores
 
setDenominatorToN() - Method in class flanagan.analysis.Stat
 
setDenominatorToN() - Method in class flanagan.math.Matrix
 
setDenominatorToNminusOne() - Method in class flanagan.analysis.ProbabilityPlot
 
setDenominatorToNminusOne() - Static method in class flanagan.analysis.Regression
 
setDenominatorToNminusOne() - Method in class flanagan.analysis.Scores
 
setDenominatorToNminusOne() - Method in class flanagan.analysis.Stat
 
setDensity() - Method in class jhplot.HPlot3D
Set density type of plot
setDensity(boolean) - Method in class jhplot.HPlot3D
Set density plot
setDeriv(double[][]) - Method in class flanagan.interpolation.BiCubicSpline
 
setDeriv(double, double) - Method in class flanagan.interpolation.CubicSpline
 
setDeriv(double[]) - Method in class flanagan.interpolation.CubicSpline
 
setDeriv(Object) - Method in class flanagan.interpolation.PolyCubicSpline
 
setDeriv(double[][][][]) - Method in class flanagan.interpolation.QuadriCubicSpline
 
setDeriv(double[][][]) - Method in class flanagan.interpolation.TriCubicSpline
 
setDerivative(Function) - Method in class jhplot.math.num.root.NewtonRootFinder
Modify the derivative of the target function.
setDerivLimits(double, double) - Method in class flanagan.interpolation.CubicSpline
 
setDerivLimits() - Method in class flanagan.interpolation.CubicSpline
 
setDescription(String[]) - Method in class hep.aida.ref.dataset.DataStatistics
Set the description for all the coordinates.
setDescription(int, String) - Method in class hep.aida.ref.dataset.DataStatistics
Set the description for a given coordinate
setDetltaTime(int) - Method in class jhplot.HCellular
Set set delta time
setDimension(int) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setDimension(int) - Method in class jhplot.P1D
Set the dimension.
setDimension(int) - Method in class umontreal.iro.lecuyer.randvarmulti.IIDMultivariateGen
Changes the dimension of the vector to d.
setDimention(int) - Method in class jminhep.cluster.DataHolder
Set the dimension of the data
setDisplayGrids(boolean) - Method in class jhplot.HPlot3D
Display grid
setDisplayXY(boolean) - Method in class jhplot.HPlot3D
Display or not X and Y
setDisplayZ(boolean) - Method in class jhplot.HPlot3D
Display or not title for Z
setDistance(double) - Method in class jhplot.HPlot3D
Set distance to the object
setDistribution(ChiSquaredDistribution) - Method in class org.apache.commons.math.stat.inference.ChiSquareTestImpl
Modify the distribution used to compute inference statistics.
setDistribution(TDistribution) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Deprecated. in 2.2 (to be removed in 3.0).
setDistribution(TDistribution) - Method in class org.apache.commons.math.stat.regression.SimpleRegression
Deprecated. in 2.2 (to be removed in 3.0).
setDivergenceTolerance(double) - Method in class cern.colt.matrix.tdouble.algo.solver.DefaultDoubleIterationMonitor
Sets the relative divergence tolerance
setDivergenceTolerance(double) - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
Sets the relative divergence tolerance
setDivergenceTolerance(float) - Method in class cern.colt.matrix.tfloat.algo.solver.DefaultFloatIterationMonitor
Sets the relative divergence tolerance
setDivergenceTolerance(float) - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
Sets the relative divergence tolerance
setDivisions(int, int) - Method in class jhplot.FPR
Set number of divisions for parameters.
setDivisions(int) - Method in class jhplot.HPlot3D
Set number of divisions for surface plots
setDLSeparation(float) - Method in class jhplot.jadraw.JaArcObject
Sets the double line separation property.
setDLSeparation(float) - Method in class jhplot.jadraw.JaLineObject
Sets the double line property.
setDLSeparation(float) - Method in class jhplot.jadraw.JaLoopObject
Sets the double line property.
setDotted(double) - Method in class jhplot.shapes.HShape
Set dotted line
setDoubleLine(boolean) - Method in class jhplot.jadraw.JaArcObject
Sets the double line property.
setDoubleLine(boolean) - Method in class jhplot.jadraw.JaLineObject
Sets the double line property.
setDoubleLine(boolean) - Method in class jhplot.jadraw.JaLoopObject
Sets the double line property.
setDrawLine(boolean) - Method in class jhplot.DrawOptions
Draw lines connecting points or not.
setDrawLineKey(boolean) - Method in class jhplot.DrawOptions
Draw histogram key with line or not
setDrawOption(LinePars) - Method in class jhplot.DrawOptions
Sets drawing attributes
setDrawSymbol(boolean) - Method in class jhplot.DrawOptions
Draw or not symbols
setDtot(int) - Method in class jhpro.stat.ConfidenceLevel
 
setE(double) - Method in class hephysics.vec.HepLorentzVector
Set energy
setEditable(int) - Method in class jhplot.SPlot
Specify which dataset is editable.
setEigenvalues(double, double) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleChebyshev
Sets the eigenvalue estimates.
setEigenvalues(float, float) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatChebyshev
Sets the eigenvalue estimates.
setElement(int, int, double) - Method in class flanagan.math.Matrix
 
setElement(int, int, double) - Method in class hephysics.matrix.BasicMatrix
 
setElement(int, int, double) - Method in interface hephysics.matrix.MutableMatrix
Set the given element of the matrix
setElement(int, int, double) - Method in class hephysics.matrix.SymmetricMatrix
Set a specific element
setElement(int, int, double) - Method in class hephysics.vec.Hep3Matrix
Sets the (row, column) element
setElement(int, double) - Method in interface org.apache.commons.math.util.DoubleArray
Sets the element at the specified index.
setElement(int, double) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Sets the element at the specified index.
setElevationAngle(double) - Method in class jhplot.HPlot3D
Set the elevation angle
setElitismRate(double) - Method in class org.apache.commons.math.genetics.ElitisticListPopulation
Sets the elitism rate, i.e.
setEnd(boolean) - Method in class jhplot.jadraw.JaArcObject
Sets the end property of this line object.
setEnd(boolean) - Method in class jhplot.jadraw.JaLineObject
Sets the end property of this line object.
setEndLength(double) - Method in class jhplot.shapes.Arrow
Set lenght of the ends
setEndWidth(double) - Method in class jhplot.shapes.Arrow
Set width of the ends
setEngine(String) - Method in class hep.aida.ref.fitter.Fitter
 
setEngineName(String) - Method in class hep.aida.ref.fitter.FitResult
 
setEntry(int, int, T) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Set the entry in the specified row and column.
setEntry(int, int, T) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Set the entry in the specified row and column.
setEntry(int, T) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Set a single element.
setEntry(int, double) - Method in class org.apache.commons.math.linear.ArrayRealVector
Set a single element.
setEntry(int, int, T) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Set the entry in the specified row and column.
setEntry(int, int, T) - Method in interface org.apache.commons.math.linear.FieldMatrix
Set the entry in the specified row and column.
setEntry(int, T) - Method in interface org.apache.commons.math.linear.FieldVector
Set a single element.
setEntry(int, int, double) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Set the entry in the specified row and column.
setEntry(int, double) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Set a single element.
setEntry(int, int, double) - Method in interface org.apache.commons.math.linear.RealMatrix
Set the entry in the specified row and column.
setEntry(int, int, double) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Set the entry in the specified row and column.
setEntry(int, double) - Method in interface org.apache.commons.math.linear.RealVector
Set a single element.
setEntry(int, int, T) - Method in class org.apache.commons.math.linear.SparseFieldMatrix
Set the entry in the specified row and column.
setEntry(int, T) - Method in class org.apache.commons.math.linear.SparseFieldVector
Set a single element.
setErr(boolean) - Method in class jhplot.DrawOptions
Set or not the 1st level errors on X and Y
setErr(double) - Method in class jhplot.math.ValueErr
Set error
setErrAll(boolean) - Method in class jhplot.DrawOptions
Show or not all errors (1st and 2nd level).
setErrAllToZero(String, int) - Method in class jhplot.P1D
Set all (1st and 2nd) level errors to zero.
setErrBack(double) - Method in class jhpro.stat.limit.ExpData
Set error on background
setErrColor(Color) - Method in class jhplot.DrawOptions
Set color for 1st level errors for X and Y
setErrColor(Color, double) - Method in class jhplot.DrawOptions
Set color for 1st level errors for X and Y
setErrColorX(Color) - Method in class jhplot.DrawOptions
Set color for 1st level errors in X
setErrColorY(Color) - Method in class jhplot.DrawOptions
Set color for 1st level errors in Y
setErrFill(boolean) - Method in class jhplot.DrawOptions
Fill area between lower and upper 1st-level errors
setErrFillColor(Color) - Method in class jhplot.DrawOptions
Fill color area between lower and upper 1st-level errors.
setErrFillColor(Color, double) - Method in class jhplot.DrawOptions
Fill color area between lower and upper 1st-level errors and set transparency level
setError(double) - Method in class flanagan.analysis.ErrorProp
 
setError(int, double) - Method in class jhpro.stat.DataKeeper
Set a error at index
setErrorMinus(double) - Method in class hep.aida.ref.histogram.Measurement
 
setErrorPlus(double) - Method in class hep.aida.ref.histogram.Measurement
 
setErrors(double[]) - Method in class jhplot.H1D
Sets errors of H1D histogram (for heights).
setErrors(double[]) - Method in class jhpro.stat.DataKeeper
 
setErrSqrt(int) - Method in class jhplot.P1D
Set 1st level error to sqrt of X or Y values.
setErrSys(boolean) - Method in class jhplot.DrawOptions
Show or not the 2nd level errors for X and Y values
setErrSysFill(boolean) - Method in class jhplot.DrawOptions
Fill area between lower and upper 2st-level errors
setErrSysFillColor(Color) - Method in class jhplot.DrawOptions
Fill color area between lower and upper 1st-level errors
setErrSysFillColor(Color, double) - Method in class jhplot.DrawOptions
Fill color area between lower and upper 2nd-level errors and set transparency level
setErrSysToZero(int) - Method in class jhplot.P1D
Set 2nd level errors to zero.
setErrSysX(boolean) - Method in class jhplot.DrawOptions
Set or not the 2nd level errors in X
setErrSysY(boolean) - Method in class jhplot.DrawOptions
Show or not the 2nd level errors for Y values
setErrTicSize(double) - Method in class jhplot.DrawOptions
Set the size of small tics shown at the end of error bars.
setErrToZero(int) - Method in class jhplot.P1D
Set 1st level errors to zero.
setErrX(boolean) - Method in class jhplot.DrawOptions
Set or not the 1st level errors in X
setErrY(boolean) - Method in class jhplot.DrawOptions
Show or not the 1st level errors for Y values.
setEstimate(double) - Method in class org.apache.commons.math.estimation.EstimatedParameter
Deprecated. Set a new estimated value for the parameter.
setExpansionFactor(float) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Sets the expansionFactor.
setExpansionMode(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Sets the expansionMode.
setExpForm(int) - Method in class jhplot.jadraw.JaAxes
Set exponential form.
setExponent(double) - Method in interface org.apache.commons.math.distribution.ZipfDistribution
Deprecated. as of v2.1
setExponent(double) - Method in class org.apache.commons.math.distribution.ZipfDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setEyePosition(double, double, double) - Method in class jhplot.HPlot3DP
Set position oy eye
setFftData(double[]) - Method in class flanagan.math.FourierTransform
 
setFileNumbering() - Method in class flanagan.analysis.Scores
 
setFill(boolean) - Method in class jhplot.DrawOptions
Fill or not histogram or function.
setFill(boolean) - Method in class jhplot.HPlot3D
Set fill color or not for histogram bars
setFill(boolean) - Method in class jhplot.shapes.HShape
Fill a primitive
setFillable(boolean) - Method in class hep.aida.ref.Annotation
If annotation is fillable, can modified.
setFillable(boolean) - Method in class hep.aida.ref.ManagedObject
If ManagedObject is fillable, it can modified.
setFillBox(boolean) - Method in class umontreal.iro.lecuyer.charts.BoxChart
Sets fill to true, if the boxes are to be filled.
setFillColor(Color) - Method in class jhplot.DrawOptions
Fill color of a drawing object.
setFillColor(Color) - Method in class jhplot.FPR
Set color for fill
setFillColor(Color) - Method in class jhplot.jadraw.JaFillObject
Sets the fill color of this fillColor object.
setFillColor(Color) - Method in class jhplot.jadraw.JaVertexT2
Sets the fill color of this fillColor object.
setFillColorTransparency(double) - Method in class jhplot.DrawOptions
Set color transparency used to fill an object.
setFilled(boolean) - Method in class jhplot.FPR
Set filled area or not
setFilled(boolean) - Method in class jhplot.jadraw.JaBlob
Fill or not the object
setFilled(boolean) - Method in class jhplot.jadraw.JaBox
Fill or not the object
setFilled(int, boolean) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Sets the filled flag.
setFinalValueOfX(double) - Method in class flanagan.integration.RungeKutta
 
setFirst() - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
setFirst() - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Resets the iteration
setFirst() - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
setFirst() - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Resets the iteration
setFitMethod(String) - Method in class hep.aida.ref.fitter.Fitter
 
setFitMethodName(String) - Method in class hep.aida.ref.fitter.FitResult
 
setFitParameterSettings(String, IFitParameterSettings) - Method in class hep.aida.ref.fitter.FitResult
 
setFitStatus(int) - Method in class hep.aida.ref.fitter.FitResult
 
setFittedFunction(IFunction) - Method in class hep.aida.ref.fitter.FitResult
 
setFixed(boolean) - Method in class hep.aida.ref.fitter.FitParameterSettings
 
setFixedOrder(boolean) - Method in class cern.hep.aida.bin.DynamicBin1D
Determines whether the receivers internally preserved elements may be reordered or not.
setFixedOrder(boolean) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Determines whether the receivers internally preserved elements may be reordered or not.
setFixedOrder(boolean) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Determines whether the receivers internally preserved elements may be reordered or not.
setFlip(boolean) - Method in class jhplot.jadraw.JaArcObject
Sets the flip property of this arc object.
setFlip(boolean) - Method in class jhplot.jadraw.JaLineObject
Sets the flip property of this line object.
setFlip(boolean) - Method in class jhplot.jadraw.JaLoopObject
Sets the flip property of this loop object.
setFlush(int) - Method in class jhplot.io.HFile
Set after how many events data will be flushed.
setFog(boolean) - Method in class jhplot.HPlot3DP
Set fog for objects
setFolderIsWatched(String, boolean) - Method in class hep.aida.ref.tree.Tree
This message is sent by a listener to indicate interest in a particular path within the tree.
setFont(Font) - Method in class jhplot.HKey
Sets the font to a specific value
setFont(Font) - Method in class jhplot.HLabel
Sets the font to a specific value
setFont(Font) - Method in class jhplot.HMLabel
Sets the font to a specific value
setFont(Font) - Method in class jhplot.jadraw.JaKey
Sets the textFont property of this text object.
setFont(Font) - Method in class jhplot.jadraw.JaText
Sets the textFont property of this text object.
setFont(Font) - Method in class jhplot.jadraw.JaTextBox
Sets the textFont property of this text object.
setFont(Font) - Method in class jhplot.shapes.Text
Set the font
setFontAxisX(Font, Color) - Method in class jhplot.HChart
Set font and color for X-axis (for X-Y plots)
setFontAxisY(Font, Color) - Method in class jhplot.HChart
Set font and color for Y-axis (for X-Y plots)
setFontLegent(Font) - Method in class jhplot.HChart
Set font for legent title
setFontSize(int) - Method in class jhplot.HLabelEq
Sets the font to a specific value
setFontTitle(Font) - Method in class jhplot.HChart
Set font for legent title
setFontValue(Font) - Method in class jhplot.HPlot3DP
Set Font for axis numbers
setForeground(Color) - Method in class jhplot.SPlot
Set the foreground color.
setFormat(String) - Method in class cern.colt.matrix.AbstractFormatter
Sets the way a single cell value is to be formatted.
setFormat(String) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the way a single cell value is to be formatted.
setFov(double) - Method in class jhplot.HPlot3DP
Set field of vision
setFrameColor(Color) - Method in class jhplot.HPlot3D
Set color of the frame
setFreq(float) - Method in class jhplot.jadraw.JaArcObject
Sets the freq property of this arc object.
setFreq(float) - Method in class jhplot.jadraw.JaLineObject
Sets the freq property of this line object.
setFreq(float) - Method in class jhplot.jadraw.JaLoopObject
Sets the freq property of this loop object.
setFtestSignificance(double) - Method in class flanagan.analysis.Regression
 
setFunc(IFunction) - Method in class jhplot.HFitter
Set fit functions
setFunc(String) - Method in class jhplot.HFitter
Set fit functions from predefined string.
setFunc(String, int, String, String) - Method in class jhplot.HFitter
Set functions from a script.
setFunction(Function) - Method in class jhplot.math.num.integration.AdaptiveIntegrator
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.integration.RombergIntegrator
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.integration.SimpsonsIntegrator
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.integration.TrapezoidalIntegrator
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.BisectionRootFinder
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.Bracket
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.BrentRootFinder
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.FalsePositionRootFinder
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.NewtonRootFinder
Modify the target function.
setFunction(Function) - Method in class jhplot.math.num.root.SecantRootFinder
Modify the target function.
setFunctionValueAccuracy(double) - Method in interface org.apache.commons.math.analysis.solvers.UnivariateRealSolver
Set the function value accuracy.
setFunctionValueAccuracy(double) - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverImpl
Deprecated. Set the function value accuracy.
setGamma(GammaDistribution) - Method in class org.apache.commons.math.distribution.ChiSquaredDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setGaussian(double) - Method in class flanagan.math.FourierTransform
 
setGaussian() - Method in class flanagan.math.FourierTransform
 
setGBackground(Color) - Method in class jhplot.GHMargin
Set the background of this panel
setGColor(Color) - Method in class jhplot.GHMargin
Set the color on this panel.
setGen1(RandomVariateGen) - Method in class umontreal.iro.lecuyer.randvarmulti.IIDMultivariateGen
Sets the common one-dimensional generator to gen1.
setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the geometric mean.
setGeoMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the geometric mean.
setGeometricMeanImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the gemoetric mean.
setGFont(Font) - Method in class jhplot.GHMargin
Set the font.
setGLpoints(int) - Method in class flanagan.integration.Integration
 
setGraph() - Method in class jhplot.HPlot
Set the graph from JPLot
setGraphStyle(int) - Method in class jhplot.DrawOptions
Set the style of the graph
setGRecBackground(Color) - Method in class jhplot.GHMargin
Set the background for rectangle with the text
setGrid(int, boolean) - Method in class jhplot.HPlot
Sets whether or not using grid lines.
setGrid(boolean) - Method in class jhplot.HPlot
Sets whether or not using grid lines.
setGrid(boolean) - Method in class jhplot.SPlot
Control whether the grid is drawn.
setGridAll(int, boolean) - Method in class jhplot.HPlot
Sets or not the grid lines for all plots on the same canvas
setGridAll(int, boolean) - Method in class jhplot.HPlotJa
Sets or not the grid lines for all plots on the same canvas
setGridColor(Color) - Method in class jhplot.jadraw.JaAxes
Set grid color
setGridColorAll(Color) - Method in class jhplot.HPlot
Sets color of the grid lines for all plots on the same canvas
setGridFront(boolean) - Method in class jhplot.jadraw.JaAxes
Set grid to be drown in fron of all graphic objects
setGridToFront(boolean) - Method in class jhplot.HPlot
Setting the flag to true, this will draw the grid after drawing all the lines and point stuff, hence on the foreground.
setGTitle(String, Font, Color) - Method in class jhplot.GHPanel
Sets the global title
setGTitle(String, Font) - Method in class jhplot.GHPanel
Sets the global title using black color.
setGTitle(String) - Method in class jhplot.GHPanel
Set the global title with default attributes.
setGTitle(String, double) - Method in class jhplot.GHPanel
Set the global title with default attributes.
setGTitle(String, Color) - Method in class jhplot.GHPanel
Set the global title.
setGTitle(String) - Method in class jhplot.HPlot2D
Set global title for this plot.
setGTitle(JaText) - Method in class jhplot.HPlotJa
Set the global title
setGTitle(String, Font, Color) - Method in class jhplot.HPlotJa
Sets the global title
setGTitle(String, Font) - Method in class jhplot.HPlotJa
Sets the global title using black color.
setGTitle(String) - Method in class jhplot.HPlotJa
Set the global title with default attributes.
setGTitle(String, Color) - Method in class jhplot.HPlotJa
Set the global title with default attributes.
setGTitle(String) - Method in class jhplot.SPlot
Set global title for this plot.
setHamming() - Method in class flanagan.math.FourierTransform
 
setHann() - Method in class flanagan.math.FourierTransform
 
setHeights(double[]) - Method in class jhplot.H1D
Sets the content of H1D histogram (heights).
setHistogram(IHistogram1D) - Method in class hep.aida.ref.histogram.Cloud1D
Set the Histogram representation of the Cloud.
setHistogram(IHistogram2D) - Method in class hep.aida.ref.histogram.Cloud2D
Set the Histogram representation of the Cloud.
setHistogram(IHistogram3D) - Method in class hep.aida.ref.histogram.Cloud3D
Set the Histogram representation of the Cloud.
setIEEEFlags(int) - Method in class org.apache.commons.math.dfp.DfpField
Sets the IEEE 854 status flags.
setIEEEFlagsBits(int) - Method in class org.apache.commons.math.dfp.DfpField
Sets some bits in the IEEE 854 status flags, without changing the already set bits.
setIgnored(boolean) - Method in class org.apache.commons.math.estimation.WeightedMeasurement
Deprecated. Set the ignore flag to the specified value Setting the ignore flag to true allow to reject wrong measurements, which sometimes can be detected only rather late.
setImaginaryCharacter(String) - Method in class org.apache.commons.math.complex.ComplexFormat
Modify the imaginaryCharacter.
setImaginaryFormat(NumberFormat) - Method in class org.apache.commons.math.complex.ComplexFormat
Modify the imaginaryFormat.
setImpulses(boolean, int) - Method in class jhplot.SPlot
If the first argument is true, then a line will be drawn from any plotted point in the specified dataset down to the x axis.
setIncGammaMaxIter(int) - Static method in class flanagan.analysis.Stat
 
setIncGammaTol(double) - Static method in class flanagan.analysis.Stat
 
setIndex(int) - Method in class org.apache.commons.math.linear.RealVector.Entry
Set the index of the entry.
setInflip(boolean) - Method in class jhplot.jadraw.JaLineObject
Sets the inflip property of this line object.
setInitFile(String) - Method in class jhplot.HCellular
Set initialization file
setInitialStep(double) - Method in class org.apache.commons.math.optimization.general.NonLinearConjugateGradientOptimizer
Set the initial step used to bracket the optimum in line search.
setInitialStepBoundFactor(double) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Deprecated. Set the positive input variable used in determining the initial step bound.
setInitialStepBoundFactor(double) - Method in class org.apache.commons.math.optimization.general.LevenbergMarquardtOptimizer
Set the positive input variable used in determining the initial step bound.
setInitialStepSize(double) - Method in class org.apache.commons.math.ode.nonstiff.AdaptiveStepsizeIntegrator
Set the initial step size.
setInitialValueOfX(double) - Method in class flanagan.integration.RungeKutta
 
setInitialValueOfY(double) - Method in class flanagan.integration.RungeKutta
 
setInitialValueOfY(double[]) - Method in class flanagan.integration.RungeKutta
 
setInitialValuesOfY(double) - Method in class flanagan.integration.RungeKutta
 
setInitialValuesOfY(double[]) - Method in class flanagan.integration.RungeKutta
 
setInitString(String) - Method in class jhplot.HCellular
Set initialization string for the rule
setInnerColor(Color) - Method in class jhplot.HPlot
Sets the color used to fill the inner triangles.
setIntegrationFunction(IntegralFunction) - Method in class flanagan.integration.Integration
 
setInterpolatedTime(double) - Method in class org.apache.commons.math.ode.ContinuousOutputModel
Set the time of the interpolated point.
setInterpolatedTime(double) - Method in interface org.apache.commons.math.ode.jacobians.StepInterpolatorWithJacobians
Deprecated. Set the time of the interpolated point.
setInterpolatedTime(double) - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Set the time of the interpolated point.
setInterpolatedTime(double) - Method in interface org.apache.commons.math.ode.sampling.StepInterpolator
Set the time of the interpolated point.
setInterpolationControl(boolean, int) - Method in class org.apache.commons.math.ode.nonstiff.GraggBulirschStoerIntegrator
Set the interpolation order control parameter.
setIsospin(float) - Method in class hephysics.particle.HEParticle
Set isospin
setIsResizing(boolean) - Method in class jhplot.jadraw.JaArcObject
Sets the resizing property of this arc.
setIsValid(boolean) - Method in class hep.aida.ref.fitter.FitResult
 
setItemDeletionPercentage(double) - Method in class flanagan.analysis.Scores
 
setIterationMonitor(DoubleIterationMonitor) - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterativeSolver
 
setIterationMonitor(DoubleIterationMonitor) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterativeSolver
Sets iteration monitor
setIterationMonitor(FloatIterationMonitor) - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterativeSolver
 
setIterationMonitor(FloatIterationMonitor) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterativeSolver
Sets iteration monitor
setIterationReporter(DoubleIterationReporter) - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
setIterationReporter(DoubleIterationReporter) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Sets new iteration reporter
setIterationReporter(FloatIterationReporter) - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
setIterationReporter(FloatIterationReporter) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Sets new iteration reporter
setKaiser(double) - Method in class flanagan.math.FourierTransform
 
setKaiser() - Method in class flanagan.math.FourierTransform
 
setKey(int, double, Color) - Method in class jhplot.HKey
Sets a key
setKey(int) - Method in class jhplot.jadraw.JaKey
Set the key symbol (1-12, 20,21,22)
setKeyColor(Color) - Method in class jhplot.jadraw.JaKey
Set the key color
setKeySpace(double) - Method in class jhplot.HKey
Sets a space between the key and the text describing the key
setKeySpace(double) - Method in class jhplot.jadraw.JaKey
Set a space between a key and a text
setKeyTextSpace(double) - Method in class jhplot.HPlotJa
Set space between the key symbol and the text in a legend.
setKurtosisImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the kurtosis.
setLabel(String) - Method in class umontreal.iro.lecuyer.charts.Axis
Sets the axis description.
setLabelColor(Color) - Method in class jhplot.HPlot3D
Set color of the label
setLabelColor(Color) - Method in class jhplot.HPlot3DP
Set Color for the labels
setLabelColor(Color) - Method in class jhplot.jadraw.JaAxes
Set the color for labels indicating the ticks
setLabelFont(Font) - Method in class jhplot.HPlot3D
Set Font for the labels
setLabelFont(Font) - Method in class jhplot.HPlot3DP
Set Font for the labels
setLabelFont(Font) - Method in class jhplot.jadraw.JaAxes
Set label fonts
setLabelFont(String) - Method in class jhplot.SPlot
Set the label font, which is used for axis labels and legend labels.
setLabelFontColor(Color) - Method in class jhplot.HPlot3D
Set color for labels
setLabelOffsetX(double) - Method in class jhplot.HPlot3D
Set label offset on X
setLabelOffsetY(double) - Method in class jhplot.HPlot3D
Set label offset on Y
setLabelOffsetZ(double) - Method in class jhplot.HPlot3D
Set label offset on Z
setLabelRotation(double) - Method in class jhplot.jadraw.JaAxes
Set rotation for labels
setLabels(double) - Method in class umontreal.iro.lecuyer.charts.Axis
Sets a periodic label display.
setLabels(double[]) - Method in class umontreal.iro.lecuyer.charts.Axis
Sets the position of each label on this axis.
setLabels(double[], String[]) - Method in class umontreal.iro.lecuyer.charts.Axis
Assigns custom labels to user-defined positions on the axis.
setLabelsAuto() - Method in class umontreal.iro.lecuyer.charts.Axis
Calculates and sets an automatic tick unit.
setLabelShift(int, double, double) - Method in class jhplot.HPlotJa
Shift position of a label with respect to the axis by about defined in NDC (0-1).
setLabelSpace(int, double) - Method in class jhplot.jadraw.JaAxes
Set a space between axis and labels for ticks
setLabelX(String, int, int) - Method in class jhplot.HPlotJa
Sets a label for X at the default location
setLabelY(String, int, int) - Method in class jhplot.HPlotJa
Set label at the default postion
setLabelY(JaText[][]) - Method in class jhplot.HPlotJa
Set labels on Y
setLambda(double) - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
Sets the value of λ for this object.
setLambda(double) - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
Sets the λ associated with this object.
setLatexDocFlag(boolean) - Method in class umontreal.iro.lecuyer.charts.CategoryChart
Same as in XYChart.
setLatexDocFlag(boolean) - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Same as in XYChart.
setLatexDocFlag(boolean) - Method in class umontreal.iro.lecuyer.charts.XYChart
Flag to remove the \documentclass (and other) commands in the created LATEX files.
setLatexFS(int) - Method in class jhplot.jadraw.JaLatexText
Sets the latexfs property of this text object.
setLatexLabel(String) - Method in class jhplot.jadraw.JaLatexText
Sets the Label of this LatexText to str.
setLegend(boolean) - Method in class jhplot.DrawOptions
Sets whether or not this line style should draw the name in the legend of the graph.
setLegend(boolean) - Method in class jhplot.HPlot
Sets whether or not to draw the legend.
setLegendFont(Font) - Method in class jhplot.HPlot
Sets the actual font of the legend.
setLegendFont(String) - Method in class jhplot.HPlot
Set the label font, which is used for axis labels and legend labels.
setLegendFont(Font) - Method in class jhplot.HPlotJa
Sets the actual font of the legend.
setLegendFont(String) - Method in class jhplot.HPlotJa
Set the label font, which is used for axis labels and legend labels.
setLegendPos(int, double) - Method in class jhplot.HPlot
Sets the x or y coordinates (defined relative to the data ranges on the axes) of the legend.
setLegendPos(double, double, String) - Method in class jhplot.HPlot
Sets the x and y coordinates of the legend.
setLegendPosUse(boolean) - Method in class jhplot.HPlot
Sets whether or not to set the legend position in X,Y coordinates as defined by the graph.
setLegendSpac(double) - Method in class jhplot.HPlot
Sets the vertical spacing, between each line of the legend.
setLengthFromBeginning(double[], int) - Static method in class jhplot.math.ArrayMathUtils
Sets an array to the specified length scraping or padding the end if necessary.
setLengthFromBeginning(int[], int) - Static method in class jhplot.math.ArrayMathUtils
Sets an array to the specified length scraping or padding the end if necessary.
setLengthFromEnd(double[], int) - Static method in class jhplot.math.ArrayMathUtils
Sets an array to the specified length scraping or padding the beginning if necessary.
setLengthFromEnd(int[], int) - Static method in class jhplot.math.ArrayMathUtils
Sets an array to the specified length scraping or padding the beginning if necessary.
setLimitGuess(double) - Method in class jhpro.stat.limit.StatConfidence
Set new limit
setLimits(double, double) - Method in class flanagan.integration.Integration
 
setLinearSeed(int[]) - Method in class umontreal.iro.lecuyer.rng.F2NL607
This method is discouraged for normal use.
setLineColor(Color) - Method in class jhplot.FPR
Set color for lines
setLinePars(LinePars) - Method in class jhplot.P1D
Sets LinePars class for graphical attributes
setLineSearchSolver(UnivariateRealSolver) - Method in class org.apache.commons.math.optimization.general.NonLinearConjugateGradientOptimizer
Set the solver to use during line search.
setLineWidth(int) - Method in class jhplot.HKey
Sets key line width
setLocation(double, double) - Method in class jhplot.HKey
Sets the location of the label in data coordinates.
setLocation(double, double, String) - Method in class jhplot.HKey
Sets the location of the label in data coordinates.
setLocation(double, double) - Method in class jhplot.HLabel
Sets the location of the label in data coordinates.
setLocation(double, double, String) - Method in class jhplot.HLabel
Sets the location of the label in data coordinates.
setLocation(double, double) - Method in class jhplot.HLabelEq
Sets the location of the label in data coordinates.
setLocation(double, double, String) - Method in class jhplot.HLabelEq
Sets the location of the label in data coordinates.
setLocation(double, double, String) - Method in class jhplot.jadraw.JaObject
Set location of the object in the NDC or USER coordinates.
setLocation(int, int) - Method in class jhplot.jadraw.JaObject
Sets the x and y coordinate of this object.
setLocation(double) - Method in class jhplot.math.num.pdf.Weibull
Modify the location parameter.
setLocationAtCenter(JaText) - Method in class jhplot.HPlotJa
Sets the location of a text object at the center of the canvas
setLocationXY(int, int, int, int) - Method in class jhplot.jadraw.JaBox
Set box location in pixel coordinates
setLocationXY(int, int, int, int) - Method in class jhplot.jadraw.JaLine
Set location in pixel coordinates
setLock(Object) - Method in class hep.aida.ref.tree.Tree
 
setLogScale(int, boolean) - Method in class jhplot.HPlot
Sets true or false to plot on a log scale.
setLogScale(int, boolean) - Method in class jhplot.HPlotJa
Sets true or false to plot on a log scale.
setLogScale(int, boolean) - Method in class jhplot.jadraw.JaAxes
Sets true or false to plot on a log scale.
setLower(double) - Method in class jhplot.math.num.pdf.Uniform
Modify the lower bound parameter.
setLowerBound(double) - Method in class hep.aida.ref.fitter.FitParameterSettings
 
setLowerBound(double) - Method in class hep.aida.ref.function.Range
Set the lower bound.
setLowerEdge(double) - Method in class hep.aida.ref.histogram.Cloud1D
Set the Cloud's lower edge
setLowerEdgeX(double) - Method in class hep.aida.ref.histogram.Cloud2D
Set the Cloud's x lower edge
setLowerEdgeX(double) - Method in class hep.aida.ref.histogram.Cloud3D
Set the Cloud's x lower edge
setLowerEdgeY(double) - Method in class hep.aida.ref.histogram.Cloud2D
Set the Cloud's y lower edge
setLowerEdgeY(double) - Method in class hep.aida.ref.histogram.Cloud3D
Set the Cloud's y lower edge
setLowerEdgeZ(double) - Method in class hep.aida.ref.histogram.Cloud3D
Set the Cloud's z lower edge
setLowerLimit(double) - Method in class flanagan.integration.Integration
 
setlowerLimit(double) - Method in class flanagan.integration.Integration
 
setLRB(double[]) - Method in class jhpro.stat.ConfidenceLevel
 
setLRS(double[]) - Method in class jhpro.stat.ConfidenceLevel
 
setLU(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Sets the combined lower and upper triangular factor, LU.
setLU(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Sets the combined lower and upper triangular factor, LU.
setLU(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Sets the combined lower and upper triangular factor, LU.
setManualRange(double[]) - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Sets new x-axis and y-axis bounds, with format: axisRange = [xmin, xmax, ymin, ymax].
setManualRange(double[]) - Method in class umontreal.iro.lecuyer.charts.XYChart
Sets the x and y ranges of the chart using the format: range = [xmin, xmax, ymin, ymax].
setManualRange(double[], boolean, boolean) - Method in class umontreal.iro.lecuyer.charts.XYChart
Sets the x and y ranges of the chart using the format: range = [xmin, xmax, ymin, ymax].
setManualRange00(double[], boolean, boolean) - Method in class umontreal.iro.lecuyer.charts.XYChart
Sets the x and y ranges of the chart using the format: range = [xmin, xmax, ymin, ymax].
setManuelRange(double[], boolean, boolean) - Method in class umontreal.iro.lecuyer.charts.HistogramChart
 
setMargin(double) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Sets the margin which is a percentage amount by which the bars are trimmed for all series.
setMarginBackground(Color) - Method in class jhplot.GHPanel
Set color for all global margins
setMarginBottom(double) - Method in class jhplot.HPlot
Sets the distance between the bottom-border of the panel and the bottom X-axis.
setMarginBottom(double) - Method in class jhplot.HPlotJa
Margin from bottom.
setMarginLeft(double) - Method in class jhplot.HPlot
Sets the distance between the left-border of the panel and the left Y-axis.
setMarginLeft(double) - Method in class jhplot.HPlotJa
Margin from left
setMarginRight(double) - Method in class jhplot.HPlot
Sets the distance between the right-border of the panel and the right Y-axis.
setMarginRight(double) - Method in class jhplot.HPlotJa
Set margin from right
setMarginSizeBottom(double) - Method in class jhplot.GHPanel
Set size of the bottom margin of global canvas in terms of the ratio to the size of the main panel
setMarginSizeLeft(double) - Method in class jhplot.GHPanel
Set the size of left margin in term of the ratio to the global panel
setMarginSizeRight(double) - Method in class jhplot.GHPanel
Set the size of right margin of the global canvas in terms of the ration to the global panel in X
setMarginSizeTop(double) - Method in class jhplot.GHPanel
Set size of the top margin of global canvas in terms of the ratio to the size of the main panel
setMarginTop(double) - Method in class jhplot.HPlot
Sets the distance between the top-border of the panel and the top X-axis.
setMarginTop(double) - Method in class jhplot.HPlotJa
Set margin from top in NDC system.
setMarginX(double) - Method in class jhplot.HPlotJa
Margin in X between pads
setMarginY(double) - Method in class jhplot.HPlotJa
Margin in Y between pads
setMarksStyle(String) - Method in class jhplot.SPlot
Set the marks style to "none", "points", "dots", or "various".
setMarksStyle(String, int) - Method in class jhplot.SPlot
Set the marks style to "none", "points", "dots", "various", or "pixels" for the specified dataset.
setMarksType(int, String) - Method in class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
Adds marks on points to a data series.
setMarksType(int, String) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Adds marks on points to a data series.
setMass(double) - Method in class hephysics.particle.LParticle
Set a mass
setMatrix(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleAMG
 
setMatrix(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleDiagonal
 
setMatrix(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleICC
 
setMatrix(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleIdentity
 
setMatrix(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleILU
 
setMatrix(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleILUT
 
setMatrix(DoubleMatrix2D) - Method in interface cern.colt.matrix.tdouble.algo.solver.preconditioner.DoublePreconditioner
Sets the operator matrix for the preconditioner.
setMatrix(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleSSOR
 
setMatrix(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatAMG
 
setMatrix(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatDiagonal
 
setMatrix(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatICC
 
setMatrix(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatIdentity
 
setMatrix(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatILU
 
setMatrix(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatILUT
 
setMatrix(FloatMatrix2D) - Method in interface cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatPreconditioner
Sets the operator matrix for the preconditioner.
setMatrix(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatSSOR
 
setMax(double) - Method in class jhplot.F1D
Set the maximum value in X
setMax(double) - Method in class jhplot.FND
Set the maximum value in X
setMax(double) - Method in class jhplot.H1D
Set Maximum value of axis
setMax(double) - Method in class jhplot.HProf1D
Set Maximum value of axis
setMax(int, double) - Method in class jhplot.jadraw.JaAxes
Set min values
setMaxCostEval(int) - Method in class org.apache.commons.math.estimation.AbstractEstimator
Deprecated. Set the maximal number of cost evaluations allowed.
setMaxEvaluations(int) - Method in class org.apache.commons.math.ode.AbstractIntegrator
Set the maximal number of differential equations function evaluations.
setMaxEvaluations(int) - Method in class org.apache.commons.math.ode.jacobians.FirstOrderIntegratorWithJacobians
Deprecated. Set the maximal number of differential equations function evaluations.
setMaxEvaluations(int) - Method in interface org.apache.commons.math.ode.ODEIntegrator
Set the maximal number of differential equations function evaluations.
setMaxEvaluations(int) - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in interface org.apache.commons.math.optimization.MultivariateRealOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in class org.apache.commons.math.optimization.univariate.AbstractUnivariateRealOptimizer
Set the maximal number of functions evaluations.
setMaxEvaluations(int) - Method in interface org.apache.commons.math.optimization.UnivariateRealOptimizer
Set the maximal number of functions evaluations.
setMaxGrowth(double) - Method in class org.apache.commons.math.ode.MultistepIntegrator
Set the maximal growth factor for stepsize control.
setMaxGrowth(double) - Method in class org.apache.commons.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Set the maximal growth factor for stepsize control.
setMaximalIterationCount(int) - Method in interface org.apache.commons.math.ConvergingAlgorithm
Deprecated. Set the upper limit for the number of iterations.
setMaximalIterationCount(int) - Method in class org.apache.commons.math.ConvergingAlgorithmImpl
Deprecated. Set the upper limit for the number of iterations.
setMaximalIterationCount(int) - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Set the upper limit for the number of iterations.
setMaxImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the maximum.
setMaxImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the maximum.
setMaximumIterations(int) - Method in class flanagan.integration.RungeKutta
 
setMaximumIterations(int) - Method in class jhplot.math.num.IterativeMethod
Modify the maximum number of iterations.
setMaximumIterations(int) - Method in class jhplot.math.num.root.Bracket
Modify the maximum number of iterations.
setMaximumRelativeError(double) - Method in class jhplot.math.num.IterativeMethod
Modify the maximum relative error.
setMaxIterations(int) - Method in class cern.colt.matrix.tdouble.algo.solver.DefaultDoubleIterationMonitor
Sets maximum number of iterations to permit
setMaxIterations(int) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Sets maximum number of iterations to permit
setMaxIterations(int) - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
 
setMaxIterations(int) - Method in class cern.colt.matrix.tfloat.algo.solver.DefaultFloatIterationMonitor
Sets maximum number of iterations to permit
setMaxIterations(int) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Sets maximum number of iterations to permit
setMaxIterations(int) - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
 
setMaxIterations(int) - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in interface org.apache.commons.math.optimization.DifferentiableMultivariateVectorialOptimizer
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in class org.apache.commons.math.optimization.general.AbstractLeastSquaresOptimizer
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in class org.apache.commons.math.optimization.general.AbstractScalarDifferentiableOptimizer
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in class org.apache.commons.math.optimization.linear.AbstractLinearOptimizer
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in interface org.apache.commons.math.optimization.linear.LinearOptimizer
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateRealOptimizer
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in class org.apache.commons.math.optimization.MultiStartDifferentiableMultivariateVectorialOptimizer
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in class org.apache.commons.math.optimization.MultiStartMultivariateRealOptimizer
Set the maximal number of iterations of the algorithm.
setMaxIterations(int) - Method in interface org.apache.commons.math.optimization.MultivariateRealOptimizer
Set the maximal number of iterations of the algorithm.
setMaxNumberOfSubticsLog(int) - Method in class jhplot.HPlot
Sets the maximum number of subticks allowed for log10 scale.
setMaxTest(int) - Method in class flanagan.math.Maximisation
 
setMaxValue(int, double) - Method in class jhplot.HPlot
Sets the maximum data value displayed on the axis.
setMaxX(double) - Method in class jhplot.F2D
Set Max value in X
setMaxX(double) - Method in class jhplot.F3D
Set Max value in X
setMaxY(double) - Method in class jhplot.F2D
Set Max value in Y
setMaxY(double) - Method in class jhplot.F3D
Set Max value in Y
setMaxZ(double) - Method in class jhplot.F3D
Set Max value in Z
setMean(double) - Method in class cern.jet.random.Poisson
Sets the mean.
setMean(double) - Method in class cern.jet.random.PoissonSlow
Sets the mean.
setMean(double) - Method in class cern.jet.random.tdouble.Poisson
Sets the mean.
setMean(double) - Method in class cern.jet.random.tdouble.PoissonSlow
Sets the mean.
setMean(double) - Method in class hep.aida.ref.histogram.Profile1D
 
setMean(double) - Method in class jhplot.math.num.pdf.Exponential
Modify the mean.
setMean(double) - Method in class jhplot.math.num.pdf.Laplace
Modify the mean.
setMean(double) - Method in class jhplot.math.num.pdf.Logistic
Modify the mean.
setMean(double) - Method in class jhplot.math.num.pdf.LogNormal
Modify the mean.
setMean(double) - Method in class jhplot.math.num.pdf.Normal
Modify the mean.
setMean(double) - Method in class jhplot.math.num.pdf.Poisson
Modify the mean.
setMean(double) - Method in interface org.apache.commons.math.distribution.ExponentialDistribution
Deprecated. as of v2.1
setMean(double) - Method in class org.apache.commons.math.distribution.ExponentialDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setMean(double) - Method in interface org.apache.commons.math.distribution.NormalDistribution
Deprecated. as of v2.1
setMean(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setMean(double) - Method in interface org.apache.commons.math.distribution.PoissonDistribution
Deprecated. as of v2.1
setMean(double) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setMean(double) - Method in class umontreal.iro.lecuyer.probdist.ExponentialDistFromMean
Calls setLambda with argument 1/mean to change the mean of this distribution.
setMeanAndRms(double, double) - Method in class hep.aida.ref.histogram.Histogram1D
Set the mean of the Histogram.
setMeanAndRms(double, double) - Method in class jhplot.H1D
Sets the Mean and RMS of H1D histogram
setMeanAndRms(double, double) - Method in class jhplot.HProf1D
Sets the Mean and RMS of H1D histogram
setMeanImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the mean.
setMeanImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the mean.
setMeanX(double) - Method in class hep.aida.ref.histogram.Histogram2D
All the non-AIDA methods should go below this point.
setMeanX(double) - Method in class hep.aida.ref.histogram.Histogram3D
All the non-AIDA methods should go below this point.
setMeanX(double) - Method in class hep.aida.ref.histogram.Profile2D
 
setMeanX(double) - Method in class jhplot.H2D
Set mean on X.
setMeanX(double) - Method in class jhplot.HProf2D
Set mean on X.
setMeanY(double) - Method in class hep.aida.ref.histogram.Histogram2D
 
setMeanY(double) - Method in class hep.aida.ref.histogram.Histogram3D
 
setMeanY(double) - Method in class hep.aida.ref.histogram.Profile2D
 
setMeanY(double) - Method in class jhplot.H2D
Set mean on Y
setMeanY(double) - Method in class jhplot.HProf2D
Set mean on Y
setMeanZ(double) - Method in class hep.aida.ref.histogram.Histogram3D
 
setMedian(double) - Method in class jhplot.math.num.pdf.Cauchy
Modify the location parameter.
setMedian(double) - Method in interface org.apache.commons.math.distribution.CauchyDistribution
Deprecated. as of v2.1
setMedian(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setMethodBinary(int) - Method in class flanagan.math.PsRandom
 
setMethodDecimal(int) - Method in class flanagan.math.PsRandom
 
setMicropshereElements(int) - Method in class org.apache.commons.math.analysis.interpolation.MicrosphereInterpolator
Set the number of microsphere elements.
setMin(double) - Method in class jhplot.F1D
Set Min value in X
setMin(double) - Method in class jhplot.FND
Set Min value in X
setMin(double) - Method in class jhplot.H1D
Set Min value of axis
setMin(double) - Method in class jhplot.HProf1D
Set Min value of axis
setMin(int, double) - Method in class jhplot.jadraw.JaAxes
Set max value
setMinColumnWidth(int) - Method in class cern.colt.matrix.AbstractFormatter
Sets the minimum number of characters a column may have.
setMinColumnWidth(int) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the minimum number of characters a column may have.
setMinimalIterationCount(int) - Method in interface org.apache.commons.math.analysis.integration.UnivariateRealIntegrator
Set the lower limit for the number of iterations.
setMinimalIterationCount(int) - Method in class org.apache.commons.math.analysis.integration.UnivariateRealIntegratorImpl
Set the lower limit for the number of iterations.
setMinImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the minimum.
setMinImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the minimum.
setMinReduction(double) - Method in class org.apache.commons.math.ode.MultistepIntegrator
Set the minimal reduction factor for stepsize control.
setMinReduction(double) - Method in class org.apache.commons.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Set the minimal reduction factor for stepsize control.
setMinTest(int) - Method in class flanagan.analysis.Regression
 
setMinTest(int) - Method in class flanagan.math.Minimisation
 
setMinValue(int, double) - Method in class jhplot.HPlot
Sets the start-value displayed on the axis.
setMinX(double) - Method in class jhplot.F2D
Set Min in X
setMinX(double) - Method in class jhplot.F3D
Set Min in X
setMinY(double) - Method in class jhplot.F2D
Set Min value in Y
setMinY(double) - Method in class jhplot.F3D
Set Min value in Y
setMinZ(double) - Method in class jhplot.F3D
Set Min value in Z
setMissingDataOption(int) - Method in class flanagan.analysis.Scores
 
setMode(int) - Method in class org.apache.commons.math.random.ValueServer
Setter for property mode.
setMove(double, double, double) - Method in class jhplot.HView3D
Move the current plot
setMu(double) - Method in class org.apache.commons.math.random.ValueServer
Setter for property mu.
setMu(double[]) - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalGen
Sets the mean vector to mu.
setMu(int, double) - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalGen
Sets the i-th component of the mean vector to mui.
setMuGeom(double) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Sets the drift parameter (interest rate) of the geometric term.
setMultiText(String[]) - Method in class jhplot.jadraw.JaTextBox
Set multiline text
setN(int) - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
Sets the parameter n of this object.
setN(int) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
Sets the parameter n of this object.
setN(int) - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
Sets the parameter n of this object.
setN(int) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
Sets the parameter n of this object.
setN(int) - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
Sets the parameter n of this object.
setN(int) - Method in class umontreal.iro.lecuyer.probdist.StudentDist
Sets the parameter n associated with this object.
setN(int) - Method in class umontreal.iro.lecuyer.probdist.WatsonGDist
Sets the parameter n of this object.
setN(int) - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
Sets the parameter n of this object.
setName(String) - Method in class hep.aida.ref.ManagedObject
Set the name of this ManagedObject.
setName(String) - Method in class jhplot.F1D
Sets a name of the function, i.e.
setName(String) - Method in class jhplot.F2D
Sets a name of the function, i.e.
setName(String) - Method in class jhplot.F3D
Sets a name of the function, i.e.
setName(String) - Method in class jhplot.FND
Sets a name of the function, i.e.
setName(String) - Method in class jhplot.HChart
Set global title to the current chart.
setName(String) - Method in class jhplot.HPlot
Sets a title for the current plot.
setName(String, Font, Color) - Method in class jhplot.HPlot
Sets a title for the current plot with all attributes
setName(String, Font) - Method in class jhplot.HPlot
Sets a title for the current plot with all attributes
setName(String) - Method in class jhplot.HPlot2D
Set global title to the current chart
setName(String) - Method in class jhplot.PND
Set a new title
setName(String) - Method in class jhplot.v3d.Object3d
 
setName(int, String) - Method in class jminhep.cluster.DataHolder
Set the title for ith component
setName(int, String) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Sets the name of the selected series.
setName(String) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Sets the global name of this list to name.
setName(String) - Method in class umontreal.iro.lecuyer.stat.StatProbe
Sets the name of this statistical collector to name.
setNamePos(double, double, String) - Method in class jhplot.HPlot
Sets the position for the title of the current plot.
setNamePos(double, double) - Method in class jhplot.HPlot
Sets the position for the title of the current plot.
setNameX(String) - Method in class jhplot.DrawOptions
Set the name for X-axis.
setNameX(String) - Method in class jhplot.HChart
Sets the name for X axis.
setNameX(String, Font, Color) - Method in class jhplot.HPlot
Set the label for the axis in X
setNameX(String) - Method in class jhplot.HPlot
Sets the name for X axis.
setNameX(String, Font) - Method in class jhplot.HPlot
Sets the name for X axis.
setNameX(String) - Method in class jhplot.HPlot2D
Sets the name for X axis.
setNameX(String) - Method in class jhplot.HPlot3D
Set a name for X axis
setNameX(String) - Method in class jhplot.HPlot3DP
Set a name for X axis
setNameX(String, Font, Color) - Method in class jhplot.HPlotJa
Set the label for the axis in X
setNameX(String) - Method in class jhplot.HPlotJa
Sets the name for X axis.
setNameX(String, Font) - Method in class jhplot.HPlotJa
Sets the name for X axis.
setNameX(String) - Method in class jhplot.SPlot
Set the label for the X (horizontal) axis.
setNameXpos(double, double, String) - Method in class jhplot.HPlot
Sets the position for label on X axis.
setNameXpos(double, double) - Method in class jhplot.HPlot
Sets the position for label on X axis in NDC system.
setNameY(String) - Method in class jhplot.DrawOptions
Sets the name for Y-axis.
setNameY(String) - Method in class jhplot.HChart
Sets the name for Y axis.
setNameY(String) - Method in class jhplot.HPlot
Sets the name for Y axis.
setNameY(String, Font) - Method in class jhplot.HPlot
Sets the name for Y axis.
setNameY(String, Font, Color) - Method in class jhplot.HPlot
Sets the Title for Y-axis
setNameY(String) - Method in class jhplot.HPlot2D
Sets the name for Y axis.
setNameY(String) - Method in class jhplot.HPlot3D
Set a name for Y axis
setNameY(String) - Method in class jhplot.HPlot3DP
Set a name for Y axis
setNameY(String, Font, Color) - Method in class jhplot.HPlotJa
Set the label for the axis in Y
setNameY(String) - Method in class jhplot.HPlotJa
Sets the name for Y axis.
setNameY(String, Font) - Method in class jhplot.HPlotJa
Sets the name for Y axis.
setNameY(String) - Method in class jhplot.SPlot
Set the label for the Y (vertical) axis.
setNameYpos(double, double, String) - Method in class jhplot.HPlot
Sets the position for label on Y axis.
setNameYpos(double, double) - Method in class jhplot.HPlot
Sets the position for label on Y axis in NDC system.
setNameZ(String) - Method in class jhplot.DrawOptions
Sets the title for Z-axis
setNameZ(String) - Method in class jhplot.HPlot3D
Set a name for Z axis
setNameZ(String) - Method in class jhplot.HPlot3DP
Set a name for Z axis
setNandP(int, double) - Method in class cern.jet.random.Binomial
Sets the parameters number of trials and the probability of success.
setNandP(int, double) - Method in class cern.jet.random.NegativeBinomial
Sets the parameters number of trials and the probability of success.
setNandP(int, double) - Method in class cern.jet.random.tdouble.Binomial
Sets the parameters number of trials and the probability of success.
setNandP(int, double) - Method in class cern.jet.random.tdouble.NegativeBinomial
Sets the parameters number of trials and the probability of success.
setNdf(int) - Method in class hep.aida.ref.fitter.FitResult
 
setNEntries(int) - Method in class hep.aida.ref.histogram.Histogram
Developer area.
setNEntries(int) - Method in class hep.aida.ref.histogram.Profile1D
 
setNEntries(int) - Method in class hep.aida.ref.histogram.Profile2D
 
setNEntries(int) - Method in class jhplot.H1D
Sets number of entries of H1D histogram.
setNEntries(int) - Method in class jhplot.H2D
Set all entries.
setNEntries(int) - Method in class jhplot.HProf1D
Sets number of entries of the histogram.
setNEntries(int) - Method in class jhplot.HProf2D
Set all entries.
setNintervals(int) - Method in class flanagan.integration.Integration
 
setNmax(int) - Method in class flanagan.analysis.Regression
 
setNmax(int) - Method in class flanagan.math.Maximisation
 
setNmax(int) - Method in class flanagan.math.Minimisation
 
setNMC(double) - Method in class jhpro.stat.limit.StatConfidence
Set number of MC events
setNMcontract(double) - Method in class flanagan.analysis.Regression
 
setNMcontract(double) - Method in class flanagan.math.Maximisation
 
setNMcontract(double) - Method in class flanagan.math.Minimisation
 
setNMextend(double) - Method in class flanagan.analysis.Regression
 
setNMextend(double) - Method in class flanagan.math.Maximisation
 
setNMextend(double) - Method in class flanagan.math.Minimisation
 
setNMreflect(double) - Method in class flanagan.analysis.Regression
 
setNMreflect(double) - Method in class flanagan.math.Maximisation
 
setNMreflect(double) - Method in class flanagan.math.Minimisation
 
setNobs(int) - Method in class jhpro.stat.limit.ExpData
Set number of observations
setNoIntercept(boolean) - Method in class org.apache.commons.math.stat.regression.AbstractMultipleLinearRegression
 
setNonGraphicItems() - Method in class jhplot.HCellular
Creates a CARule and a CAConfig.
setNonLinearData(int[][]) - Static method in class umontreal.iro.lecuyer.rng.F2NL607
Selects new data for the components of the non-linear generator.
setNonLinearSeed(int[]) - Method in class umontreal.iro.lecuyer.rng.F2NL607
This method is discouraged for normal use.
setNormal(NormalDistribution) - Method in class org.apache.commons.math.distribution.PoissonDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setNormalGen(NormalGen) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Sets the normal generator.
setNormalization(boolean, boolean) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setNormalizationRange(double, double, int) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setNormType(Norm) - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterationMonitor
 
setNormType(Norm) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterationMonitor
Sets the vector-norm to calculate with
setNormType(Norm) - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterationMonitor
 
setNormType(Norm) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterationMonitor
Sets the vector-norm to calculate with
setNPoints(int) - Method in class jhplot.HBsom
Set number of points for fit
setNrestartsMax(int) - Method in class flanagan.analysis.Regression
 
setNrestartsMax(int) - Method in class flanagan.math.Maximisation
 
setNrestartsMax(int) - Method in class flanagan.math.Minimisation
 
setNu(int) - Method in class umontreal.iro.lecuyer.probdist.ChiDist
Sets the value of ν for this object.
setNumberOfElements(int) - Method in interface org.apache.commons.math.distribution.ZipfDistribution
Deprecated. as of v2.1
setNumberOfElements(int) - Method in class org.apache.commons.math.distribution.ZipfDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setNumberOfFailures(int) - Method in class jhplot.math.num.pdf.Hypergeometric
Modify the number of failures.
setNumberOfParameters(int) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setNumberOfSimulations(int) - Method in class flanagan.analysis.PCA
 
setNumberOfSuccesses(int) - Method in class jhplot.math.num.pdf.Hypergeometric
Modify the number of successes.
setNumberOfSuccesses(int) - Method in class jhplot.math.num.pdf.NegativeBinomial
Modify the number of successes.
setNumberOfSuccesses(int) - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Deprecated. as of v2.1
setNumberOfSuccesses(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setNumberOfSuccesses(int) - Method in interface org.apache.commons.math.distribution.PascalDistribution
Deprecated. as of v2.1
setNumberOfSuccesses(int) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setNumberOfTics(int, boolean) - Method in class jhplot.HPlot
Says whether the user fixes the number of ticks for a specific axis.
setNumberOfTics(boolean) - Method in class jhplot.HPlot
Says whether the user fixes the number of ticks for a specific for all axises.
setNumberOfTics(int, int) - Method in class jhplot.HPlot
Sets the number of ticks for the specified axis.
setNumberOfTrials(int) - Method in class jhplot.math.num.pdf.Binomial
Modify the number of trials.
setNumberOfTrials(int) - Method in interface org.apache.commons.math.distribution.BinomialDistribution
Deprecated. as of v2.1
setNumberOfTrials(int) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setNumElements(int) - Method in class org.apache.commons.math.util.ResizableDoubleArray
This function allows you to control the number of elements contained in this array, and can be used to "throw out" the last n values in an array.
setNumeratorDegreesOfFreedom(double) - Method in class jhplot.math.num.pdf.FDistribution
Modify the numerator degrees of freedom.
setNumeratorDegreesOfFreedom(double) - Method in interface org.apache.commons.math.distribution.FDistribution
Deprecated. as of v2.1
setNumeratorDegreesOfFreedom(double) - Method in class org.apache.commons.math.distribution.FDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setNumeratorFormat(NumberFormat) - Method in class org.apache.commons.math.fraction.AbstractFormat
Modify the numerator format.
setObject(Object) - Method in class hep.aida.ref.ContainerManagedObject
 
setObservable(IsObservable) - Method in class hep.aida.ref.event.ObserverAdapter
 
setObservationTimes(double[], int) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCAEqualSteps
 
setObservationTimes(double, int) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCAEqualSteps
 
setObservationTimes(double[], int) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCA
Sets the observation times of the GammaProcessPCA and the BrownianMotionPCA.
setObservationTimes(double[], int) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCABridge
 
setObservationTimes(double[], int) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
 
setObservationTimes(double[], int) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Sets the observation times on the geometric process and the underlying Lévy process.
setObservationTimes(double[], int) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessPCA
Sets the observation times of both the InverseGaussianProcessPCA and the inner
BrownianMotionPCA.
setObservationTimes(double[], int) - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Sets the observation times on the NIG process as usual, but also sets the observation times of the underlying InverseGaussianProcess.
setObservationTimes(double[], int) - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Sets the observation times of the process to a copy of T, with t0 = T[0] and td = T[d].
setObservationTimes(double, int) - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Sets equidistant observation times at tj = , for j = 0,..., d, and delta = δ.
setObservationTimes(double[], int) - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Sets the observation times on the VarianceGammaProcess as usual, but also sets the observation times of the underlying GammaProcess.
setObservationTimes(double[], int) - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
Sets the observation times on the VarianceGammaProcesDiff as usual, but also sets the observation times of the underlying GammaProcess'es.
setOmega(double, double) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleSSOR
Sets the overrelaxation parameters
setOmega(float, float) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatSSOR
Sets the overrelaxation parameters
setOneWayAnova(OneWayAnova) - Static method in class org.apache.commons.math.stat.inference.TestUtils
Deprecated. 2.2 will be removed in 3.0 - not compatible with use from multiple threads
setOrderControl(int, double, double) - Method in class org.apache.commons.math.ode.nonstiff.GraggBulirschStoerIntegrator
Set the order control parameters.
setOrthoTolerance(double) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Deprecated. Set the desired max cosine on the orthogonality.
setOrthoTolerance(double) - Method in class org.apache.commons.math.optimization.general.LevenbergMarquardtOptimizer
Set the desired max cosine on the orthogonality.
setOtherStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Sets the otherStream, which is the stream used to choose between the two roots in the MSH method.
setOutlineWidth(int, double) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Sets the outline width in pt.
setOutputFileType(int) - Method in class flanagan.analysis.Scores
 
setOverlapOption(boolean) - Method in class flanagan.math.FourierTransform
 
setOverwrite() - Method in class hep.aida.ref.tree.Tree
Set the strategy of what should happen if two objects have the same path.
setOverwrite(boolean) - Method in class hep.aida.ref.tree.Tree
Set the strategy of what should happen if two objects have the same path.
SetOwner() - Method in class jhpro.stat.DataSource
Initialize all arrays
setP(double) - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
Resets the value of p associated with this object.
setPackageLinearSeed(int[]) - Static method in class umontreal.iro.lecuyer.rng.F2NL607
Sets the initial seed of the linear part of the class F2NL607 to the 19 integers of the vector seed[0..18].
setPackageNonLinearSeed(int[]) - Static method in class umontreal.iro.lecuyer.rng.F2NL607
Sets the non-linear part of the initial seed of the class F2NL607 to the n integers of the vector seed[0..n-1], where n is the number of components of the non-linear part.
setPackageSeed(int[]) - Static method in class umontreal.iro.lecuyer.rng.GenF2w32
Sets the initial seed of the class GenF2w2r32 to the 25 integers of the vector seed[0..24].
setPackageSeed(int[]) - Static method in class umontreal.iro.lecuyer.rng.LFSR113
Sets the initial seed for the class LFSR113 to the four integers of the vector seed[0..3].
setPackageSeed(long[]) - Static method in class umontreal.iro.lecuyer.rng.LFSR258
Sets the initial seed for the class LFSR258 to the five integers of array seed[0..4].
setPackageSeed(int[]) - Static method in class umontreal.iro.lecuyer.rng.MRG31k3p
Sets the initial seed for the class MRG31k3p to the six integers of the vector seed[0..5].
setPackageSeed(long[]) - Static method in class umontreal.iro.lecuyer.rng.MRG32k3a
Sets the initial seed for the class MRG32k3a to the six integers in the vector seed[0..5].
setPackageSeed(long[]) - Static method in class umontreal.iro.lecuyer.rng.MRG32k3aL
 
setPackageSeed(long[]) - Static method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated. Sets the initial seed for the class RandMrg to the six integers in the vector seed[0..5].
setPackageSeed(byte[]) - Static method in class umontreal.iro.lecuyer.rng.RandRijndael
Sets the initial seed for the class RandRijndael to the 16 bytes of the vector seed[0..15].
setPackageSeed(int[]) - Static method in class umontreal.iro.lecuyer.rng.WELL1024
Sets the initial seed of this class to the 32 integers of array seed[0..31].
setPackageSeed(int[]) - Static method in class umontreal.iro.lecuyer.rng.WELL512
Sets the initial seed of the class WELL512 to the 16 integers of the vector seed[0..15].
setPackageSeed(int[]) - Static method in class umontreal.iro.lecuyer.rng.WELL607
Sets the initial seed of the class WELL607 to the 19 integers of the vector seed[0..18].
setPad(double, double, double, double) - Method in class jhplot.HPlotJa
Set the location and the size of the current pad in NDC coordinate.
setPad(int, int, double, double, double, double) - Method in class jhplot.HPlotJa
Set the location and the size of the pad in NDC coordinate.
setPad(int, int, double, double) - Method in class jhplot.HPlotJa
Set the location and the size of the pad in NDC coordinate.
setPad(int, int) - Method in class jhplot.jadraw.JaAxes
Set pad ID
setPadLocation(double, double) - Method in class jhplot.HPlotJa
Set location of the current pad in NDC You may need to call update.
setPadSize(double, double) - Method in class jhplot.HPlotJa
Set width and height of the pad in NDC
setPadX(int) - Method in class jhplot.jadraw.JaKey
Set pad ID in X
setPadX(int) - Method in class jhplot.jadraw.JaText
Set pad ID in X
setPadX(int) - Method in class jhplot.jadraw.JaTextBox
Set pad ID in X
setPadY(int) - Method in class jhplot.jadraw.JaKey
Set pad ID in Y
setPadY(int) - Method in class jhplot.jadraw.JaText
Set pad ID in Y
setPadY(int) - Method in class jhplot.jadraw.JaTextBox
Set pad ID in Y
setPanelSize(Dimension) - Method in class jhplot.HPlot
Sets the dimensions of the panel of the graph.
setPar(double[]) - Method in class hep.aida.ref.function.JELCompiledExpression.ValueProvider
 
setPar(String, double) - Method in class jhplot.F1D
Replace abstract parameter with the value (double).
setPar(String, int) - Method in class jhplot.F1D
Replace abstract parameter with the value (integer).
setPar(String, double) - Method in class jhplot.HFitter
Set parameter to a value
setParallelAnalysisPercentileValue(double) - Method in class flanagan.analysis.PCA
 
setParam(double, double, int) - Method in class umontreal.iro.lecuyer.charts.ContinuousDistChart
Sets the parameters a, b and m for this object.
setParam(int, int) - Method in class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Sets the parameters a and b for this object.
setParam(double, double) - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
Sets the parameters α and β of this object.
setParam(double, double) - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
Sets the parameters α and β of this object.
setParam(double, double, double) - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
Sets the parameters α1, α2 and β of this object.
setParameter(String, double) - Method in class hep.aida.ref.fitter.InternalFitFunction
 
setParameter(String, double) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setParameter(String, double) - Method in class hep.aida.ref.function.AbstractIFunction
 
setParameter(String, double) - Method in class hep.aida.ref.function.BaseModelFunction
 
setParameter(String, double) - Method in class hep.aida.ref.function.FunctionCore
 
setParameter(String, double) - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
setParameter(String, double) - Method in class hep.aida.ref.function.SumOfFunctions
 
setParameter(int, double) - Method in interface org.apache.commons.math.ode.jacobians.ParameterizedODE
Deprecated. Set a parameter.
setParameterNames(String[]) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setParameterNames(String[]) - Method in class hep.aida.ref.function.BaseModelFunction
 
setParameterNames(String[]) - Method in class hep.aida.ref.function.FunctionCore
 
setParameterNames(String[]) - Method in class hep.aida.ref.function.JELCompiledExpression
 
setParameterNames(String[]) - Method in class hep.aida.ref.function.JELFunctionCore
 
setParameters(double[]) - Method in class hep.aida.ref.fitter.InternalFitFunction
 
setParameters(double[]) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setParameters(double[]) - Method in class hep.aida.ref.function.AbstractIFunction
 
setParameters(double[]) - Method in class hep.aida.ref.function.BaseModelFunction
 
setParameters(double[]) - Method in class hep.aida.ref.function.FunctionCore
 
setParameters(double[]) - Method in class hep.aida.ref.function.IFunctionCoreNotNorm
 
setParameters(double[]) - Method in class hep.aida.ref.function.SumOfFunctions
 
setParams(double) - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
Resets the parameter to this new value.
setParams(double, double, double, double, int) - Method in class umontreal.iro.lecuyer.probdist.BetaDist
 
setParams(double, double, double, double, int) - Method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
 
setParams(int, double) - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
Resets the parameters to these new values and recomputes everything as in the constructor.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
Sets the value of the parameters α and β for this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
Sets the parameters ν = nu and λ = lambda of this object.
setParams(int, double, int) - Method in class umontreal.iro.lecuyer.probdist.ErlangDist
Sets the parameters k and λ of the distribution for this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated. Sets the parameters α and λ of this object.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
Sets the parameters μ, β and γ of this object.
setParams(int, int) - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
Sets the parameters n and m of this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Sets the parameters μ and σ for this object.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
Sets the parameters α, β and δ of this object.
setParams(double, double, int) - Method in class umontreal.iro.lecuyer.probdist.GammaDist
 
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
Sets the parameters β and δ of this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Sets the parameters μ and σ.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
Sets the parameters μ and σ of this object.
setParams(int, int, int) - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
Resets the parameters of this object to m, l and k.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
Sets the parameters μ and λ of this object.
setParams(double, double, double, double) - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
Sets the value of the parameters γ, δ, ξ and λ for this object.
setParams(double, double, double, double) - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
Sets the value of the parameters γ, δ, ξ and λ for this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
Sets the parameters α and λ of this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
Sets the parameters α and β of this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
Sets the parameters μ and σ of this object.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Sets the parameters a, λ and c of this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
Sets the parameter γ and p of this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.NormalDist
Sets the parameters μ and σ of this object.
setParams(double, double, double, double) - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
Sets the parameters α, β, μ and δ of this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
Sets the parameter α and β for this object.
setParams(int, double) - Method in class umontreal.iro.lecuyer.probdist.PascalDist
Sets the parameter n and p of this object.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.probdist.PowerDist
Sets the parameters a, b and c for this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
Sets the parameters a and β for this object.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
Sets the value of the parameters a, b and m for this object.
setParams(ContinuousDistribution, double, double) - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Sets the parameters dist, a and b for this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.probdist.UniformDist
Sets the parameters a and b for this object.
setParams(int, int) - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
Sets the parameters i and j for this object.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
Sets the parameters α, λ and δ for this object.
setParams(double[]) - Method in class umontreal.iro.lecuyer.probdistmulti.DirichletDist
Sets the parameters (α1,...,αd) of this object.
setParams(int, double[]) - Method in class umontreal.iro.lecuyer.probdistmulti.MultinomialDist
Sets the parameters n and (p1,...,pd) of this object.
setParams(double[], double[][]) - Method in class umontreal.iro.lecuyer.probdistmulti.MultiNormalDist
Sets the parameters μ and Σ of this object.
setParams(double, double[]) - Method in class umontreal.iro.lecuyer.probdistmulti.NegativeMultinomialDist
Sets the parameters γ and (p1,...,pd) of this object.
setParams(double, double, double, double) - Method in class umontreal.iro.lecuyer.randvar.NormalInverseGaussianGen
Sets the parameters α, β, μ and δ of this object.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.randvar.Pearson6Gen
Sets the parameters α1, α2 and β of this object.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.randvar.PowerGen
Sets the parameters a, b and c for this object.
setParams(double, double) - Method in class umontreal.iro.lecuyer.randvar.RayleighGen
Sets the parameters a = a and β = beta for this object.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.randvar.WeibullGen
Sets the parameters α, λ and δ for this object.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Resets the parameters X(t0) = x0, μ = mu and σ = sigma of the process.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotionPCA
 
setParams(double, double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
Resets the parameters X(t0) = x0, α = alpha, b = b and σ = sigma of the process.
setParams(double, double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
Resets the parameters X(t0) = x0, α = alpha, b = b and σ = sigma of the process.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcess
Sets the parameters S(t0) = s0, μ = mu and ν = nu of the process.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCA
Sets the parameters s0, μ and ν to new values, and sets the variance parameters of the BrownianMotionPCA to ν.
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCABridge
 
setParams(double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
Sets the parameters S(t0) = s0, μ = mu and σ = sigma of the process.
setParams(double, double, double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
Sets the parameters S(t0) = s0, θ = theta, σ = sigma, ν = nu and μ = mu of the process.
setParams(double, double) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
Sets the parameters.
setParams(double, double, double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Sets the parameters.
setParams(double, double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Resets the parameters X(t0) = x0, α = alpha, b = b and σ = sigma of the process.
setParams(double, double, double, double) - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Sets the parameters S(t0) = s0, θ = theta, σ = sigma and ν = nu of the process.
setParConstraint(String) - Method in class jhplot.HFitter
Set parameter constraint Example: Set parameter "mean1" to be identical to "mean2" as: "mean1=mean2"
setParent(LParticle) - Method in class hephysics.particle.LParticle
Set a parent particle
setParFixed(String) - Method in class jhplot.HFitter
Fix a given parameter to a constant value
setParFixed(String, boolean) - Method in class jhplot.HFitter
Fix a given parameter to a constant value or not
setParRange(String, double, double) - Method in class jhplot.HFitter
Set range for parameter during the fit
setParRelativeTolerance(double) - Method in class org.apache.commons.math.estimation.LevenbergMarquardtEstimator
Deprecated. Set the desired relative error in the approximate solution parameters.
setParRelativeTolerance(double) - Method in class org.apache.commons.math.optimization.general.LevenbergMarquardtOptimizer
Set the desired relative error in the approximate solution parameters.
setParStep(String, double) - Method in class jhplot.HFitter
Set step size for parameter (say 0.01)
setPassiveEuler(double, double, double) - Method in class hephysics.vec.Hep3Matrix
Defines a rotation matrix via Euler angles.
setPdgcode(int) - Method in class hephysics.particle.HEParticle
Set PDG code
setPenColor(Color) - Method in class jhplot.P3D
Sets the symbol color
setPenDash() - Method in class jhplot.DrawOptions
Set dashed style with default length
setPenDash(int) - Method in class jhplot.DrawOptions
Set dashed style with default length
setPenWidth(int) - Method in class jhplot.DrawOptions
Set width of the lines
setPenWidth(int) - Method in class jhplot.FPR
Set width of lines
setPenWidth(float) - Method in class jhplot.jadraw.JaKey
Set a pen width used to draw the key
setPenWidth(float) - Method in class jhplot.jadraw.JaLine
Set line width
setPenWidth(int) - Method in class jhplot.P3D
Set width of the lines
setPenWidthAxes(int) - Method in class jhplot.HPlot3D
Set line width to draw axes
setPenWidthAxis(double) - Method in class jhplot.HPlot
Set pen width to draw axis
setPenWidthErr(int) - Method in class jhplot.DrawOptions
Set width of the lines used to show 1st level errors
setPenWidthErrSys(int) - Method in class jhplot.DrawOptions
Set width of the lines used to show 2nd level errors
setPercentileImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation to be used by DescriptiveStatistics.getPercentile(double).
setPersonDeletionPercentage(double) - Method in class flanagan.analysis.Scores
 
setPhi(double) - Method in class hephysics.vec.Hep3Vector
Set phi
setPlotLineOption(int) - Method in class flanagan.math.FourierTransform
 
setPlotPointOption(int) - Method in class flanagan.math.FourierTransform
 
setPlotsNum(int, int) - Method in class jhplot.GHFrame
Set the number of plots
setPlotStyle(int, String) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Selects the plot style for a given series.
setPoint(int, IDataPoint) - Method in class hep.aida.ref.histogram.DataPointSet
Set the IDataPoint at a give index in the set.
setPoints(int) - Method in class jhplot.F1D
Sets the number points between Min and Max for evaluation
setPoints(int) - Method in class jhplot.F2D
Get the number of points
setPoints(int) - Method in class jhplot.F3D
Get the number of points
setPoints(int) - Method in class jhplot.FND
Sets the number points between Min and Max for evaluation
setPolicyFIFO() - Method in class umontreal.iro.lecuyer.simprocs.Bin
Sets the service policy for ordering processes waiting for tokens on the bin to FIFO (first in, first out): the processes are placed in the list (and served) according to their order of arrival.
setPolicyFIFO() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Set the service policy to FIFO (first in, first out): the processes are placed in the list (and served) according to their order of arrival.
setPolicyLIFO() - Method in class umontreal.iro.lecuyer.simprocs.Bin
Sets the service policy for ordering processes waiting for tokens on the bin to LIFO (last in, first out): the processes are placed in the list (and served) according to their inverse order of arrival: the last arrived are served first.
setPolicyLIFO() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Set the service policy to LIFO (last in, first out): the processes are placed in the list (and served) according to their inverse order of arrival, the last arrived are served first.
setPopulationLimit(int) - Method in class org.apache.commons.math.genetics.ListPopulation
Sets the maximal population size.
setPopulationSize(int) - Method in class jhplot.HCellular
Set population size
setPopulationSize(int) - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Deprecated. as of v2.1
setPopulationSize(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setPos(String, int, int) - Method in class jhplot.HGraph
Set vertex position
setPosCoord(String) - Method in class jhplot.shapes.HShape
Set the style of the coodinate position
setPosition(HepLorentzVector) - Method in class hephysics.particle.HEParticle
Set position of particle in X,Y,Z,time.
setPositionCoordinate(int) - Method in class jhplot.shapes.HShape
How to set the position of this object?
setPositiveReflection(boolean) - Method in class umontreal.iro.lecuyer.randvar.KernelDensityGen
After this method is called with true, the generator will produce only positive values, by using the reflection method: replace all negative values by their absolute values.
setPreconditioner(DoublePreconditioner) - Method in class cern.colt.matrix.tdouble.algo.solver.AbstractDoubleIterativeSolver
 
setPreconditioner(DoublePreconditioner) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterativeSolver
Sets preconditioner
setPreconditioner(DoublePreconditioner) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleQMR
 
setPreconditioner(FloatPreconditioner) - Method in class cern.colt.matrix.tfloat.algo.solver.AbstractFloatIterativeSolver
 
setPreconditioner(FloatPreconditioner) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterativeSolver
Sets preconditioner
setPreconditioner(FloatPreconditioner) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatQMR
 
setPreconditioner(Preconditioner) - Method in class org.apache.commons.math.optimization.general.NonLinearConjugateGradientOptimizer
Set the preconditioner.
setPrimitivesToFront(boolean) - Method in class jhplot.HPlot
Setting the flag to true, this will draw all primitives after drawing all the lines and point stuff, hence on the foreground.
setPrintShape(boolean) - Method in class cern.colt.matrix.AbstractFormatter
Specifies whether a string representation of a matrix is to be preceded with a summary of its shape.
setPrintShape(boolean) - Method in class cern.colt.matrix.impl.AbstractFormatter
Specifies whether a string representation of a matrix is to be preceded with a summary of its shape.
setPriority(double) - Method in class umontreal.iro.lecuyer.simevents.Event
Sets the priority of this event to inPriority.
setPriority(double) - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Sets the priority assigned to the current variable in the simulation.
setProbab(double) - Method in class jminhep.cluster.Partition
Set probability for cluster accosiation
setProbabilityOfSuccess(double) - Method in class jhplot.math.num.pdf.Binomial
Modify probability of success.
setProbabilityOfSuccess(double) - Method in class jhplot.math.num.pdf.Geometric
Modify probability of success.
setProbabilityOfSuccess(double) - Method in class jhplot.math.num.pdf.NegativeBinomial
Modify probability of success.
setProbabilityOfSuccess(double) - Method in interface org.apache.commons.math.distribution.BinomialDistribution
Deprecated. as of v2.1
setProbabilityOfSuccess(double) - Method in class org.apache.commons.math.distribution.BinomialDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setProbabilityOfSuccess(double) - Method in interface org.apache.commons.math.distribution.PascalDistribution
Deprecated. as of v2.1
setProbabilityOfSuccess(double) - Method in class org.apache.commons.math.distribution.PascalDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setprobFlag(boolean) - Method in class umontreal.iro.lecuyer.charts.XYChart
Must be set true when plotting probabilities, false otherwise.
setProperty(Property) - Method in class cern.colt.matrix.linalg.Algebra
Attaches the given property object to this Algebra, defining tolerance.
setProperty(DoubleProperty) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Attaches the given property object to this Algebra, defining tolerance.
setProperty(DoubleProperty) - Method in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Attaches the given property object to this Algebra, defining tolerance.
setProperty(FloatProperty) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Attaches the given property object to this Algebra, defining tolerance.
setProperty(FloatProperty) - Method in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Attaches the given property object to this Algebra, defining tolerance.
setProvidesGradient(boolean) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setProvidesParameterGradient(boolean) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setPx(double) - Method in class hephysics.vec.HepLorentzVector
Set Px
setPxPyPz(double, double, double) - Method in class hephysics.particle.LParticle
Set Px,Py,Pz (or x,y,z)
setPxPyPzE(double, double, double, double) - Method in class hephysics.particle.LParticle
Set Px,Py,Pz (or x,y,z) and energy
setPy(double) - Method in class hephysics.vec.HepLorentzVector
Set Py
setPz(double) - Method in class hephysics.vec.HepLorentzVector
Set Pz
setQRRankingThreshold(double) - Method in class org.apache.commons.math.optimization.general.LevenbergMarquardtOptimizer
Set the desired threshold for QR ranking.
setQuality(double) - Method in class hep.aida.ref.fitter.FitResult
 
setQuantile(double) - Method in class org.apache.commons.math.stat.descriptive.rank.Percentile
Sets the value of the quantile field (determines what percentile is computed when evaluate() is called with no quantile argument).
setQuick(int, boolean) - Method in class cern.colt.list.BooleanArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, byte) - Method in class cern.colt.list.ByteArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, char) - Method in class cern.colt.list.CharArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, long) - Method in class cern.colt.list.DistinctNumberList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, double) - Method in class cern.colt.list.DoubleArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, float) - Method in class cern.colt.list.FloatArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, int) - Method in class cern.colt.list.IntArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, long) - Method in class cern.colt.list.LongArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, long) - Method in class cern.colt.list.MinMaxNumberList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, Object) - Method in class cern.colt.list.ObjectArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, short) - Method in class cern.colt.list.ShortArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, boolean) - Method in class cern.colt.list.tboolean.BooleanArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, byte) - Method in class cern.colt.list.tbyte.ByteArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, char) - Method in class cern.colt.list.tchar.CharArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, double) - Method in class cern.colt.list.tdouble.DoubleArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, float) - Method in class cern.colt.list.tfloat.FloatArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, int) - Method in class cern.colt.list.tint.IntArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, long) - Method in class cern.colt.list.tlong.DistinctNumberList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, long) - Method in class cern.colt.list.tlong.LongArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, long) - Method in class cern.colt.list.tlong.MinMaxNumberList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, Object) - Method in class cern.colt.list.tobject.ObjectArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, short) - Method in class cern.colt.list.tshort.ShortArrayList
Replaces the element at the specified position in the receiver with the specified element; WARNING: Does not check preconditions.
setQuick(int, double) - Method in class cern.colt.matrix.DoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.DoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, double) - Method in class cern.colt.matrix.DoubleMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, double) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, double) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, Object) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.impl.DenseObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.impl.DenseObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, double) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, Object) - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, Object) - Method in class cern.colt.matrix.ObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.ObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.ObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, double, double) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
setQuick(int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
setQuick(int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
setQuick(int, int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
setQuick(int, int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
 
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix2D
 
setQuick(int, int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix3D
 
setQuick(int, int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DenseLargeDComplexMatrix3D
 
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCMDComplexMatrix2D
 
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCMDComplexMatrix2D
 
setQuick(int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
setQuick(int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
 
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
setQuick(int, int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
setQuick(int, int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCMDComplexMatrix2D
 
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCMDComplexMatrix2D
 
setQuick(int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
setQuick(int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
setQuick(int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
setQuick(int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
setQuick(int, int, int, double[]) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
setQuick(int, int, int, double, double) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
setQuick(int, double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, double) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
setQuick(int, double) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
setQuick(int, int, int, double) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix2D
 
setQuick(int, int, int, double) - Method in class cern.colt.matrix.tdouble.impl.DenseLargeDoubleMatrix3D
 
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.impl.SparseCCMDoubleMatrix2D
 
setQuick(int, double) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
setQuick(int, int, int, double) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.impl.SparseRCMDoubleMatrix2D
 
setQuick(int, double) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
setQuick(int, int, double) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
setQuick(int, int, int, double) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
setQuick(int, float, float) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
setQuick(int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
setQuick(int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
setQuick(int, int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
setQuick(int, int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
 
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix2D
 
setQuick(int, int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix3D
 
setQuick(int, int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DenseLargeFComplexMatrix3D
 
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCMFComplexMatrix2D
 
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCMFComplexMatrix2D
 
setQuick(int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
setQuick(int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
 
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
setQuick(int, int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
setQuick(int, int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCMFComplexMatrix2D
 
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCMFComplexMatrix2D
 
setQuick(int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
setQuick(int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
setQuick(int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
setQuick(int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
setQuick(int, int, int, float[]) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
setQuick(int, int, int, float, float) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
setQuick(int, float) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, float) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
setQuick(int, float) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
setQuick(int, int, int, float) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix2D
 
setQuick(int, int, int, float) - Method in class cern.colt.matrix.tfloat.impl.DenseLargeFloatMatrix3D
 
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.impl.SparseCCMFloatMatrix2D
 
setQuick(int, float) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
setQuick(int, int, int, float) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.impl.SparseRCMFloatMatrix2D
 
setQuick(int, float) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
setQuick(int, int, float) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
setQuick(int, int, int, float) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
setQuick(int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
setQuick(int, int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseLargeIntMatrix2D
 
setQuick(int, int, int, int) - Method in class cern.colt.matrix.tint.impl.DenseLargeIntMatrix3D
 
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.SparseCCMIntMatrix2D
 
setQuick(int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
setQuick(int, int, int, int) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.SparseRCMIntMatrix2D
 
setQuick(int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
setQuick(int, int, int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
setQuick(int, int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix2D
 
setQuick(int, int, int, long) - Method in class cern.colt.matrix.tlong.impl.DenseLargeLongMatrix3D
 
setQuick(int, long) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
setQuick(int, int, int, long) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.impl.SparseCCMLongMatrix2D
 
setQuick(int, long) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
setQuick(int, int, int, long) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.impl.SparseRCMLongMatrix2D
 
setQuick(int, long) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
setQuick(int, int, int, long) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
setQuick(int, long) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, long) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, long) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix2D
 
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.tobject.impl.DenseLargeObjectMatrix3D
 
setQuick(int, Object) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.impl.DiagonalObjectMatrix2D
 
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.impl.SparseCCMObjectMatrix2D
 
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
setQuick(int, Object) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.impl.SparseRCMObjectMatrix2D
 
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
setQuick(int, Object) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
setQuick(int, Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Sets the matrix cell at coordinate index to the specified value.
setQuick(int, int, Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Sets the matrix cell at coordinate [row,column] to the specified value.
setQuick(int, int, int, Object) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Sets the matrix cell at coordinate [slice,row,column] to the specified value.
setRa(int) - Method in class umontreal.iro.lecuyer.simevents.Event
 
setRandomGenerator(RandomGenerator) - Static method in class org.apache.commons.math.genetics.GeneticAlgorithm
Set the (static) random generator.
setRandomSeed(long) - Static method in class hep.aida.ref.function.FunctionUtils
 
setRandomStreamClass(Class) - Method in class umontreal.iro.lecuyer.rng.BasicRandomStreamFactory
Sets the associated random stream class to rsClass.
setRange(int, int) - Method in class hep.aida.ref.tuple.TupleEvent
 
setRange(int, double, double) - Method in class jhplot.HChart
Sets the range (min-max) displayed on the axis.
setRange(double, double) - Method in class jhplot.HFitter
Set range for fitting for 1D objects (H1D, P1D)
setRange(int, double, double) - Method in class jhplot.HPlot
Sets the range (min-max) displayed on the axis.
setRange(double, double, double, double) - Method in class jhplot.HPlot
Sets the range for the current plot
setRange(int, double, double, int) - Method in class jhplot.HPlot2D
Sets the range for the current plot and axis.
setRange(double, double, double, double) - Method in class jhplot.HPlot3D
Set X and Y range for the 3D plot.
setRange(double, double, double, double, double, double) - Method in class jhplot.HPlot3D
Set X, Y, Z ranges for the 3D plot
setRange(double, double, double, double) - Method in class jhplot.HPlotJa
Set ranges on X and Y on the current pad.
setRange(int, double, double) - Method in class jhplot.jadraw.JaAxes
Set the ranges for the current pad
setRange(double, double, double, double) - Method in class jhplot.SPlot
Set range for X and Y axes.
setRange(double, double) - Method in class jhplot.stat.Interpolator
Redefine smooth interval for input data.
setRangeAll(int, double, double) - Method in class jhplot.HPlot
Sets the range (min-max) displayed on all axises.
setRangeAll(double, double, double, double) - Method in class jhplot.HPlot
Sets the range for all plots
setRangeX(double, double) - Method in class jhplot.HPlot
Sets the range (min-max) displayed on X
setRangeX(double, double) - Method in class jhplot.HPlot3DP
Set range for X axis
setRangeX(double, double) - Method in class jhplot.HPlotJa
Set range on X.
setRangeX(double, double, int, int) - Method in class jhplot.HPlotJa
Set X range on pad defined by x and y on the canvas.
setRangeY(double, double) - Method in class jhplot.HPlot
Sets the range (min-max) displayed on Y
setRangeY(double, double) - Method in class jhplot.HPlot3DP
Set range for Y
setRangeY(double, double) - Method in class jhplot.HPlotJa
Set range on Y on the current pad.
setRangeY(double, double, int, int) - Method in class jhplot.HPlotJa
Set Y range on pad defined by x and y on the canvas.
setRangeZ(double, double) - Method in class jhplot.HPlot3D
Sets the z range of calculated surface vertices.
setRangeZ(double, double) - Method in class jhplot.HPlot3DP
Set range for Z
setRealFormat(NumberFormat) - Method in class org.apache.commons.math.complex.ComplexFormat
Modify the realFormat.
setRectangular() - Method in class flanagan.math.FourierTransform
 
setRegularizationParameter(double) - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
Sets the regularization parameter
setRegularizationParameter(float) - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
Sets the regularization parameter
setRelation(String) - Method in class jminhep.cluster.DataHolder
Set relation (name) of the data holder
setRelativeAccuracy(double) - Method in interface org.apache.commons.math.ConvergingAlgorithm
Deprecated. Set the relative accuracy.
setRelativeAccuracy(double) - Method in class org.apache.commons.math.ConvergingAlgorithmImpl
Deprecated. Set the relative accuracy.
setRelativeAccuracy(double) - Method in class org.apache.commons.math.optimization.MultiStartUnivariateRealOptimizer
Set the relative accuracy.
setRelativeTolerance(double) - Method in class cern.colt.matrix.tdouble.algo.solver.DefaultDoubleIterationMonitor
Sets the relative convergence tolerance
setRelativeTolerance(float) - Method in class cern.colt.matrix.tfloat.algo.solver.DefaultFloatIterationMonitor
Sets the relative convergence tolerance
setRelh(int) - Method in class jhplot.jadraw.JaObject
Sets the relative height of this object.
setRelw(int) - Method in class jhplot.jadraw.JaObject
Sets the relative width of this object.
setRelWAndH(int, int) - Method in class jhplot.jadraw.JaObject
Sets the relative width and height of this object.
setRelWH(double, double, String) - Method in class jhplot.jadraw.JaObject
Set relative size in the NDC or USER coordinates
setRenderer(CategoryItemRenderer) - Method in class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
Sets the CategoryItemRenderer object associated with the current variable.
setRenderer(XYItemRenderer) - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Sets the XYItemRenderer object associated with the current variable.
setRestart(int) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleGMRES
Sets the restart parameter
setRestart(int) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatGMRES
Sets the restart parameter
setRms(double) - Method in class hep.aida.ref.histogram.Profile1D
 
setRmsX(double) - Method in class hep.aida.ref.histogram.Histogram2D
 
setRmsX(double) - Method in class hep.aida.ref.histogram.Histogram3D
 
setRmsX(double) - Method in class hep.aida.ref.histogram.Profile2D
 
setRmsX(double) - Method in class jhplot.H2D
Set RMS on X.
setRmsX(double) - Method in class jhplot.HProf2D
Set RMS on X.
setRmsY(double) - Method in class hep.aida.ref.histogram.Histogram2D
 
setRmsY(double) - Method in class hep.aida.ref.histogram.Histogram3D
 
setRmsY(double) - Method in class hep.aida.ref.histogram.Profile2D
 
setRmsY(double) - Method in class jhplot.H2D
Set RMS on Y
setRmsY(double) - Method in class jhplot.HProf2D
Set RMS on Y
setRmsZ(double) - Method in class hep.aida.ref.histogram.Histogram3D
 
setRootFile(File) - Method in class jhplot.root.RootHistogramBrowser
 
setRootFile(URL) - Method in class jhplot.root.RootHistogramBrowser
 
setRot(float, float, float) - Method in class jhplot.v3d.Position
 
setRotAngle(int) - Method in class jhplot.jadraw.JaBlob
Sets the rotation angle of this blob.
setRotAngle(int) - Method in class jhplot.jadraw.JaKey
Sets the rotAngle property of this text object.
setRotAngle(int) - Method in class jhplot.jadraw.JaLatexText
Sets the rotAngle property of this text object.
setRotAngle(int) - Method in class jhplot.jadraw.JaText
Sets the rotAngle property of this text object.
setRotAngle(int) - Method in class jhplot.jadraw.JaTextBox
Sets the rotAngle property of this text object.
setRotAngle(int) - Method in class jhplot.jadraw.JaVertexT2
Sets the rotation angle of this vertex.
setRotate(double, double, double) - Method in class jhplot.HView3D
Rotate the current plot
setRotateTicks(int, boolean) - Method in class jhplot.jadraw.JaAxes
Set true if ticks should be rotated
setRotation(int) - Method in class jhplot.GHMargin
Set the rotation angle of the text in degrees.
setRotation(double) - Method in class jhplot.HKey
Sets the rotation angle.
setRotation(double) - Method in class jhplot.HLabel
Sets the rotation angle.
setRotation(double) - Method in class jhplot.HMLabel
Sets the rotation angle.
setRotation(double) - Method in class jhplot.shapes.Text
Set the rotation angle
setRotationAngle(double) - Method in class jhplot.HPlot3D
Get the rotation angle
setRoundingMode(DfpField.RoundingMode) - Method in class org.apache.commons.math.dfp.DfpField
Set the rounding mode.
setRoundingMode(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Sets the rounding mode for decimal divisions.
setRoundingMode(RoundingMode) - Method in class org.apache.commons.math.util.BigReal
Sets the rounding mode for decimal divisions.
setRow(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
setRow(int) - Method in class hep.aida.ref.tuple.ChainedTuple
Set the current row.
setRow(int) - Method in interface hep.aida.ref.tuple.FTupleCursor
 
setRow(int) - Method in class hep.aida.ref.tuple.TupleCursor
 
setRow(int, T[]) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Sets the entries in row number row as a row matrix.
setRow(int, double[]) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Sets the entries in row number row as a row matrix.
setRow(int, T[]) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Sets the entries in row number row as a row matrix.
setRow(int, double[]) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Sets the entries in row number row as a row matrix.
setRow(int, T[]) - Method in interface org.apache.commons.math.linear.FieldMatrix
Sets the entries in row number row as a row matrix.
setRow(int, double[]) - Method in interface org.apache.commons.math.linear.RealMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, RealMatrix) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, FieldMatrix<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, BlockFieldMatrix<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, RealMatrix) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, BlockRealMatrix) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, FieldMatrix<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Sets the entries in row number row as a row matrix.
setRowMatrix(int, RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Sets the entries in row number row as a row matrix.
setRowSeparator(String) - Method in class cern.colt.matrix.AbstractFormatter
Sets the string separating any two rows from another.
setRowSeparator(String) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the string separating any two rows from another.
setRowVector(int, FieldVector<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Sets the entries in row number row as a vector.
setRowVector(int, RealVector) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Sets the entries in row number row as a vector.
setRowVector(int, FieldVector<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Sets the entries in row number row as a vector.
setRowVector(int, RealVector) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Sets the entries in row number row as a vector.
setRowVector(int, FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Sets the entries in row number row as a vector.
setRowVector(int, RealVector) - Method in interface org.apache.commons.math.linear.RealMatrix
Sets the entries in row number row as a vector.
setRule(String) - Method in class jhplot.HCellular
Set rule.
setSafety(double) - Method in class org.apache.commons.math.ode.MultistepIntegrator
Set the safety factor for stepsize control.
setSafety(double) - Method in class org.apache.commons.math.ode.nonstiff.EmbeddedRungeKuttaIntegrator
Set the safety factor for stepsize control.
setSampleSize(int) - Method in class jhplot.math.num.pdf.Hypergeometric
Modify the sample size.
setSampleSize(int) - Method in interface org.apache.commons.math.distribution.HypergeometricDistribution
Deprecated. as of v2.1
setSampleSize(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setScale(int) - Method in class flanagan.analysis.Regression
 
setScale(double[]) - Method in class flanagan.analysis.Regression
 
setScale(int) - Method in class flanagan.math.Maximisation
 
setScale(double[]) - Method in class flanagan.math.Maximisation
 
setScale(int) - Method in class flanagan.math.Minimisation
 
setScale(double[]) - Method in class flanagan.math.Minimisation
 
setScale(double) - Method in class jhplot.math.num.pdf.Cauchy
Modify the scale parameter.
setScale(double) - Method in class jhplot.math.num.pdf.Laplace
Modify the scale.
setScale(double) - Method in class jhplot.math.num.pdf.Logistic
Modify the scale parameter.
setScale(double) - Method in class jhplot.math.num.pdf.Rayleigh
Modify the scale parameter.
setScale(double) - Method in class jhplot.math.num.pdf.Weibull
Modify the scale parameter.
setScale(float, float, float) - Method in class jhplot.v3d.Position
 
setScale(double) - Method in interface org.apache.commons.math.distribution.CauchyDistribution
Deprecated. as of v2.1
setScale(double) - Method in class org.apache.commons.math.distribution.CauchyDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setScale(double) - Method in interface org.apache.commons.math.distribution.WeibullDistribution
Deprecated. as of v2.1
setScale(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setScale(int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Sets the scale for division operations.
setScale(int) - Method in class org.apache.commons.math.util.BigReal
Sets the scale for division operations.
setScaling(double) - Method in class jhplot.HPlot3D
Set the scaling
setScheduledEvent(Event) - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
Sets the event associated to the current variable.
setScrambleData(RandomStream, int, int[]) - Static method in class umontreal.iro.lecuyer.rng.F2NL607
Selects new data for the components of the non-linear generator.
setSecureAlgorithm(String, String) - Method in class org.apache.commons.math.random.RandomDataImpl
Sets the PRNG algorithm for the underlying SecureRandom instance using the Security Provider API.
setSeed(long) - Method in class flanagan.math.PsRandom
 
setSeed(int) - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math.random.AbstractRandomGenerator
Sets the seed of the underyling random number generator using a long seed.
setSeed(int) - Method in class org.apache.commons.math.random.AbstractWell
Reinitialize the generator as if just built with the given int seed.
setSeed(int[]) - Method in class org.apache.commons.math.random.AbstractWell
Reinitialize the generator as if just built with the given int array seed.
setSeed(long) - Method in class org.apache.commons.math.random.AbstractWell
Reinitialize the generator as if just built with the given long seed.
setSeed(int) - Method in class org.apache.commons.math.random.BitsStreamGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math.random.BitsStreamGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math.random.BitsStreamGenerator
Sets the seed of the underlying random number generator using a long seed.
setSeed(int) - Method in class org.apache.commons.math.random.JDKRandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math.random.JDKRandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(int) - Method in class org.apache.commons.math.random.MersenneTwister
Reinitialize the generator as if just built with the given int seed.
setSeed(int[]) - Method in class org.apache.commons.math.random.MersenneTwister
Reinitialize the generator as if just built with the given int array seed.
setSeed(long) - Method in class org.apache.commons.math.random.MersenneTwister
Reinitialize the generator as if just built with the given long seed.
setSeed(int) - Method in class org.apache.commons.math.random.RandomAdaptor
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in class org.apache.commons.math.random.RandomAdaptor
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in class org.apache.commons.math.random.RandomAdaptor
Sets the seed of the underlying random number generator using a long seed.
setSeed(int) - Method in interface org.apache.commons.math.random.RandomGenerator
Sets the seed of the underlying random number generator using an int seed.
setSeed(int[]) - Method in interface org.apache.commons.math.random.RandomGenerator
Sets the seed of the underlying random number generator using an int array seed.
setSeed(long) - Method in interface org.apache.commons.math.random.RandomGenerator
Sets the seed of the underlying random number generator using a long seed.
setSeed(int[]) - Method in class umontreal.iro.lecuyer.rng.GenF2w32
This method is discouraged for normal use.
setSeed(int[]) - Method in class umontreal.iro.lecuyer.rng.LFSR113
This method is discouraged for normal use.
setSeed(long[]) - Method in class umontreal.iro.lecuyer.rng.LFSR258
This method is discouraged for normal use.
setSeed(int[]) - Method in class umontreal.iro.lecuyer.rng.MRG31k3p
Use of this method is strongly discouraged.
setSeed(long[]) - Method in class umontreal.iro.lecuyer.rng.MRG32k3a
Sets the initial seed Ig of this stream to the vector seed[0..5].
setSeed(long[]) - Method in class umontreal.iro.lecuyer.rng.MRG32k3aL
 
setSeed(long[]) - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated. Sets the initial seed Ig of this stream to the vector seed[0..5].
setSeed(byte[]) - Method in class umontreal.iro.lecuyer.rng.RandRijndael
This method is discouraged for normal use.
setSeed(int[]) - Method in class umontreal.iro.lecuyer.rng.WELL1024
This method is discouraged for normal use.
setSeed(int[]) - Method in class umontreal.iro.lecuyer.rng.WELL512
This method is discouraged for normal use.
setSeed(int[]) - Method in class umontreal.iro.lecuyer.rng.WELL607
This method is discouraged for normal use.
setSegmentLength(int) - Method in class flanagan.math.FourierTransform
 
setSegmentNumber(int) - Method in class flanagan.math.FourierTransform
 
setSensitivity(double) - Method in class jhpro.stat.limit.StatConfidence
Set new sensitivity
setSensitivityError(double) - Method in class jhpro.stat.limit.StatConfidence
Set error on sensitivity
setSeriesCollection(BoxSeriesCollection) - Method in class umontreal.iro.lecuyer.charts.BoxChart
Links a new dataset to the current chart.
setSeriesCollection(EmpiricalSeriesCollection) - Method in class umontreal.iro.lecuyer.charts.EmpiricalChart
Links a new dataset to the current chart.
setSeriesCollection(HistogramSeriesCollection) - Method in class umontreal.iro.lecuyer.charts.HistogramChart
Links a new dataset to the current chart.
setSeriesCollection(XYListSeriesCollection) - Method in class umontreal.iro.lecuyer.charts.ScatterChart
Links a new dataset to the current chart.
setSeriesCollection(XYListSeriesCollection) - Method in class umontreal.iro.lecuyer.charts.XYLineChart
Links a new dataset to the current chart.
setShadow(boolean) - Method in class jhplot.HPlot
Defines whether or not a shadow will be drawn at the panel border.
setShadow(boolean) - Method in class jhplot.jadraw.JaTextBox
Sets the shadow to the box.
setShadowSize(int) - Method in class jhplot.jadraw.JaTextBox
Sets a shadow size.
setShadowXOffset(int) - Method in class jhplot.jadraw.JaTextBox
Set shadow offset in X
setShadowYOffset(int) - Method in class jhplot.jadraw.JaTextBox
Set shadow offset in Y
setShape(double) - Method in class jhplot.math.num.pdf.Weibull
Modify the shape parameter.
setShape(double) - Method in interface org.apache.commons.math.distribution.WeibullDistribution
Deprecated. as of v2.1
setShape(double) - Method in class org.apache.commons.math.distribution.WeibullDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setShow(int, boolean) - Method in class jhplot.jadraw.JaAxes
Set true if you want to show a particular axis
setShowGrid(int, boolean) - Method in class jhplot.jadraw.JaAxes
Is grid to be shown?
setShowKey(boolean) - Method in class jhplot.jadraw.JaAxes
Set true if keys are shown
setShowMirror(int, boolean) - Method in class jhplot.HPlotJa
Set or no a mirror axis
setShowMirror(int, boolean) - Method in class jhplot.jadraw.JaAxes
Set true if a mirror axis to be shown
setShowNumberObs(boolean) - Method in class umontreal.iro.lecuyer.stat.Tally
Determines if the number of observations must be displayed in reports.
setShowStatBox(boolean) - Method in class jhplot.HPlotJa
Show a box with statistics (only for last plotted object) on the current pad
setSigma(double) - Method in class org.apache.commons.math.random.ValueServer
Setter for property sigma.
setSigma(DoubleMatrix2D) - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalCholeskyGen
Sets the covariance matrix Σ of this multinormal generator to sigma (and recomputes A).
setSigma(DoubleMatrix2D) - Method in class umontreal.iro.lecuyer.randvarmulti.MultinormalPCAGen
Sets the covariance matrix Σ of this multinormal generator to sigma (and recomputes A).
setSimulator(Simulator) - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Sets the simulator associated with this probe to sim.
setSimulator(Simulator) - Method in class umontreal.iro.lecuyer.simevents.Continuous
Sets the simulator linked to this continuous-time variable.
setSimulator(Simulator) - Method in class umontreal.iro.lecuyer.simevents.Event
Sets the simulator associated with this event to sim.
setSimulator(Simulator) - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
Sets the simulator associated with this list.
setSimulator(ProcessSimulator) - Method in class umontreal.iro.lecuyer.simprocs.Bin
Set the current simulator of this continuous-time variable.
setSize(int) - Method in class cern.colt.bitvector.BitVector
Shrinks or expands the receiver so that it holds newSize bits.
setSize(int) - Method in class cern.colt.list.AbstractList
Sets the size of the receiver.
setSize(int) - Method in class cern.colt.matrix.tbit.BitVector
Shrinks or expands the receiver so that it holds newSize bits.
setSize(int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Sets the size of this matrix.
setSize(int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Sets the size of this matrix.
setSize(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Sets the size of this matrix.
setSize(int, int, int, int) - Method in class jhplot.jadraw.JaObject
Reset the size (width, height, relative width and height) of this object.
setSize(int) - Method in class jhplot.math.num.DoubleArray
Modify the size of this array.
setSize(int, int) - Method in class jhplot.SPlot
Set size of the frame.
setSizeMargin(int, int) - Method in class jhplot.GHMargin
Set size of this margin panel
setSizePanel(int, int) - Method in class jhplot.GHPanel
Set the size of the global panel which keeps the central panel and the margins
setSizeRaw(int) - Method in class cern.colt.list.tdouble.DoubleArrayList
 
setSizeRaw(int) - Method in class cern.colt.list.tfloat.FloatArrayList
 
setSizeRaw(int) - Method in class cern.colt.list.tint.IntArrayList
 
setSizeRaw(int) - Method in class cern.colt.list.tlong.AbstractLongList
Sets the size of the receiver without modifying it otherwise.
setSizeRaw(int) - Method in class cern.colt.list.tlong.DistinctNumberList
Sets the size of the receiver without modifying it otherwise.
setSizeRaw(int) - Method in class cern.colt.list.tlong.MinMaxNumberList
Sets the size of the receiver without modifying it otherwise.
setSizeRaw(int) - Method in class cern.colt.list.tobject.ObjectArrayList
Sets the size of the receiver without modifying it otherwise.
setSkewnessImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the skewness.
setSliceSeparator(String) - Method in class cern.colt.matrix.AbstractFormatter
Sets the string separating any two slices from another.
setSliceSeparator(String) - Method in class cern.colt.matrix.impl.AbstractFormatter
Sets the string separating any two slices from another.
setSoftCurrentTime(double) - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Restrict step range to a limited part of the global step.
setSoftPreviousTime(double) - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Restrict step range to a limited part of the global step.
setSpaceParity(float) - Method in class hephysics.particle.HEParticle
Set P space parity
setSpin(float) - Method in class hephysics.particle.HEParticle
Set J total spin
setStabilityCheck(boolean, int, int, double) - Method in class org.apache.commons.math.ode.nonstiff.GraggBulirschStoerIntegrator
Set the stability check controls.
setStandardDeviation(double) - Method in class jhplot.math.num.pdf.LogNormal
Modify the standard deviation.
setStandardDeviation(double) - Method in class jhplot.math.num.pdf.Normal
Modify the standard deviation.
setStandardDeviation(double) - Method in interface org.apache.commons.math.distribution.NormalDistribution
Deprecated. as of v2.1
setStandardDeviation(double) - Method in class org.apache.commons.math.distribution.NormalDistributionImpl
Deprecated. as of 2.1 (class will become immutable in 3.0)
setStangle(int) - Method in class jhplot.jadraw.JaArcObject
Sets the stangle property of this arc object.
setStartConfiguration(double[]) - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Set start configuration for simplex.
setStartConfiguration(double[][]) - Method in class org.apache.commons.math.optimization.direct.DirectSearchOptimizer
Set start configuration for simplex.
setStarterIntegrator(FirstOrderIntegrator) - Method in class org.apache.commons.math.ode.MultistepIntegrator
Set the starter integrator.
setStatBox(String[], int, int) - Method in class jhplot.HPlotJa
Set statistical box.
setStatCollecting(boolean) - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
Starts or stops collecting statistics on this list.
setStatCollecting(boolean) - Method in class umontreal.iro.lecuyer.simprocs.Bin
Starts or stops collecting statistics on the list returned by waitList for this bin.
setStatCollecting(boolean) - Method in class umontreal.iro.lecuyer.simprocs.Resource
Starts or stops collecting statistics on the lists returned by waitList and servList for this resource.
setState(double, double) - Method in class cern.jet.random.Beta
Sets the parameters.
setState(double, double, double) - Method in class cern.jet.random.BreitWigner
Sets the mean, gamma and cut parameters.
setState(double) - Method in class cern.jet.random.ChiSquare
Sets the distribution parameter.
setState(double[], int) - Method in class cern.jet.random.Empirical
Sets the distribution parameters.
setState(double[], int) - Method in class cern.jet.random.EmpiricalWalker
Sets the distribution parameters.
setState(double) - Method in class cern.jet.random.Exponential
Sets the mean.
setState(double) - Method in class cern.jet.random.ExponentialPower
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.Gamma
Sets the mean and variance.
setState(double, double) - Method in class cern.jet.random.Hyperbolic
Sets the parameters.
setState(int, int, int) - Method in class cern.jet.random.HyperGeometric
Sets the parameters.
setState(double) - Method in class cern.jet.random.Logarithmic
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.Normal
Sets the mean and variance.
setState(double) - Method in class cern.jet.random.StudentT
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.tdouble.Beta
Sets the parameters.
setState(double, double, double) - Method in class cern.jet.random.tdouble.BreitWigner
Sets the mean, gamma and cut parameters.
setState(double) - Method in class cern.jet.random.tdouble.ChiSquare
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.tdouble.DoubleUniform
Sets the internal state.
setState(double[], int) - Method in class cern.jet.random.tdouble.Empirical
Sets the distribution parameters.
setState(double[], int) - Method in class cern.jet.random.tdouble.EmpiricalWalker
Sets the distribution parameters.
setState(double) - Method in class cern.jet.random.tdouble.Exponential
Sets the mean.
setState(double) - Method in class cern.jet.random.tdouble.ExponentialPower
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.tdouble.Gamma
Sets the mean and variance.
setState(double, double) - Method in class cern.jet.random.tdouble.Hyperbolic
Sets the parameters.
setState(int, int, int) - Method in class cern.jet.random.tdouble.HyperGeometric
Sets the parameters.
setState(double) - Method in class cern.jet.random.tdouble.Logarithmic
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.tdouble.Normal
Sets the mean and variance.
setState(double) - Method in class cern.jet.random.tdouble.StudentT
Sets the distribution parameter.
setState(double) - Method in class cern.jet.random.tdouble.VonMises
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.tdouble.Zeta
Sets the parameters.
setState(float, float) - Method in class cern.jet.random.tfloat.FloatUniform
Sets the internal state.
setState(double, double) - Method in class cern.jet.random.Uniform
Sets the internal state.
setState(double) - Method in class cern.jet.random.VonMises
Sets the distribution parameter.
setState(double, double) - Method in class cern.jet.random.Zeta
Sets the parameters.
setState2(double[]) - Method in class cern.jet.random.EmpiricalWalker
Sets the distribution parameters.
setState2(double[]) - Method in class cern.jet.random.tdouble.EmpiricalWalker
Sets the distribution parameters.
setStaticDenominatorToN() - Static method in class flanagan.analysis.Stat
 
setStaticDenominatorToNminusOne() - Static method in class flanagan.analysis.Stat
 
setStaticWeightsToBigW() - Static method in class flanagan.analysis.Stat
 
setStaticWeightsToLittleW() - Static method in class flanagan.analysis.Stat
 
setStatistics(String[]) - Method in class jhplot.jadraw.JaAxes
Set a strings representing the full statistics
setStatus(int) - Method in class hephysics.particle.HEParticle
Set Monte Carlo status code
setSteadyStateThreshold(double) - Method in class org.apache.commons.math.estimation.GaussNewtonEstimator
Deprecated. Set the steady state detection threshold.
setStepSize(double) - Method in class flanagan.integration.RungeKutta
 
setStepSize(double) - Method in class hep.aida.ref.fitter.FitParameterSettings
 
setStepsizeControl(double, double, double, double) - Method in class org.apache.commons.math.ode.nonstiff.GraggBulirschStoerIntegrator
Set the step size control factors.
setSticky(String, boolean) - Method in class hep.aida.ref.Annotation
Set stickyness for a given key.
setStoppingCondition(HyBRDoubleIterationMonitor.HyBRStoppingCondition) - Method in class cern.colt.matrix.tdouble.algo.solver.HyBRDoubleIterationMonitor
Sets the stopping condition
setStoppingCondition(HyBRFloatIterationMonitor.HyBRStoppingCondition) - Method in class cern.colt.matrix.tfloat.algo.solver.HyBRFloatIterationMonitor
Sets the stopping condition
setStot(double) - Method in class jhpro.stat.ConfidenceLevel
 
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.hups.EmptyRandomization
Sets the internal RandomStream to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.hups.PointSet
Sets the random stream used to generate random shifts to stream.
setStream(RandomStream) - Method in interface umontreal.iro.lecuyer.hups.PointSetRandomization
Sets the internal RandomStream to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.hups.RandomShift
Sets the internal RandomStream to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGen
Sets the RandomStream used by this generator to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.randvarmulti.RandomMultivariateGen
Sets the RandomStream used by this object to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.BrownianMotion
Resets the random stream of the normal generator to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcess
Resets the random stream of the noncentral chi-square generator to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.CIRProcessEuler
Resets the random stream of the normal generator to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcess
Resets the RandomStream of the GammaGen to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessBridge
Resets the RandomStream of the GammaGen and the BetaGen to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.GammaProcessPCA
Resets the RandomStream of the gamma generator and the RandomStream of the inner BrownianMotionPCA to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricBrownianMotion
Resets the RandomStream for the underlying Brownian motion to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricLevyProcess
Resets the stream in the underlying Lévy process.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.GeometricVarianceGammaProcess
 
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcess
 
setStream(RandomStream, RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessBridge
Sets the streams.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessBridge
Sets both inner streams to the same stream.
setStream(RandomStream, RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Sets the streams.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessMSH
Sets both inner streams to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.InverseGaussianProcessPCA
 
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.NormalInverseGaussianProcess
Sets all internal streams to stream, including the stream(s) of the underlying InverseGaussianProcess.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.OrnsteinUhlenbeckProcess
Resets the random stream of the normal generator to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Resets the random stream of the underlying generator to stream.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Resets the RandomStream's.
setStream(RandomStream) - Method in class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
Sets the RandomStream of the two GammaProcess'es to stream.
setString(String, Font, Color, Dimension) - Method in class jhplot.GHMargin
Sets the string.
setString(String) - Method in class jhplot.GHMargin
Set the text on this panel
setString(String, Font, Color) - Method in class jhplot.GHMargin
 
setStringPositionX(double) - Method in class jhplot.GHMargin
Set the text position in X relative to the frame width
setStringPositionY(double) - Method in class jhplot.GHMargin
Set the text position in Y relative to the frame height.
setStroke(float) - Method in class jhplot.jadraw.JaArcObject
Sets the stroke property of this arc object.
setStroke(float) - Method in class jhplot.jadraw.JaFillObject
Sets the stroke (line width) of this object.
setStroke(float) - Method in class jhplot.jadraw.JaLineObject
Sets the stroke property of this line object.
setStroke(float) - Method in class jhplot.jadraw.JaLoopObject
Sets the stroke property of this loop object.
setStroke(float) - Method in class jhplot.jadraw.JaVertex
Sets the stroke property of this line object.
setStroke(Stroke) - Method in class jhplot.shapes.HShape
Set the Stroke to a specific value
setStyle(String) - Method in class jhplot.DrawOptions
Sets the style:
setStyle(int) - Method in class jhplot.HPlot2D
Set style to the current plot.
setSubMatrix(int, int, double[][]) - Method in class flanagan.math.Matrix
 
setSubMatrix(int, int, int, int, double[][]) - Method in class flanagan.math.Matrix
 
setSubMatrix(int[], int[], double[][]) - Method in class flanagan.math.Matrix
 
setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(BigDecimal[][], int, int) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(T[][], int, int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(T[][], int, int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubMatrix(double[][], int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Replace the submatrix starting at row, column using data in the input subMatrix array.
setSubTicksNumber(int, int) - Method in class jhplot.jadraw.JaAxes
Set the number of sub-ticks
setSubTicksSize(int, double) - Method in class jhplot.jadraw.JaAxes
Set the size of subtics in NDC
setSubTicLength(int, double) - Method in class jhplot.HPlot
Sets the length of the subticks.
setSubTicLength(double) - Method in class jhplot.HPlot
Sets the length of the subticks for all axises.
setSubTicLength(int, double) - Method in class jhplot.HPlot2D
Sets the length of the sub-ticks.
setSubTicNumber(int, int) - Method in class jhplot.HPlot
Sets the number of subticks between ticks.
setSubVector(int, RealVector) - Method in class org.apache.commons.math.linear.AbstractRealVector
Set a set of consecutive elements.
setSubVector(int, double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Set a set of consecutive elements.
setSubVector(int, FieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Set a set of consecutive elements.
setSubVector(int, T[]) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Set a set of consecutive elements.
setSubVector(int, RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Set a set of consecutive elements.
setSubVector(int, double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Set a set of consecutive elements.
setSubVector(int, FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldVector
Set a set of consecutive elements.
setSubVector(int, T[]) - Method in interface org.apache.commons.math.linear.FieldVector
Set a set of consecutive elements.
setSubVector(int, RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Set a set of consecutive elements.
setSubVector(int, double[]) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Set a set of consecutive elements.
setSubVector(int, RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Set a set of consecutive elements.
setSubVector(int, double[]) - Method in interface org.apache.commons.math.linear.RealVector
Set a set of consecutive elements.
setSubVector(int, FieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Set a set of consecutive elements.
setSubVector(int, T[]) - Method in class org.apache.commons.math.linear.SparseFieldVector
Set a set of consecutive elements.
setSumImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the sum.
setSumImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the Sum.
setSumImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the Sum.
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.moment.GeometricMean
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the sum of logs.
setSumLogImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the sum of logs.
setSumsqImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic[]) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Sets the implementation for the sum of squares.
setSumsqImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the sum of squares.
setSurface() - Method in class jhplot.HPlot3D
Set surface type of plot
setSurface(boolean) - Method in class jhplot.HPlot3D
Set surface type of plot
setSymbol(int) - Method in class jhplot.DrawOptions
Set symbol types
setSymbolColor(Color) - Method in class jhplot.P2D
Sets symbol color
setSymbolSize(int) - Method in class jhplot.DrawOptions
Set the size of the symbols
setSymbolSize(int) - Method in class jhplot.P2D
Sets the symbol size
setSymm(boolean) - Method in class jhplot.jadraw.JaLineObject
Sets the symm property of this line object.
setT(double) - Method in class hephysics.vec.HepLorentzVector
Set time
setText(String) - Method in class jhplot.HKey
Sets a text of the label.
setText(String) - Method in class jhplot.HLabel
Sets a text of the label.
setText(String) - Method in class jhplot.HLabelEq
Sets a equation text of the label.
setText(String[]) - Method in class jhplot.HMLabel
Sets the text of the label.
setText(String) - Method in class jhplot.jadraw.JaKey
Sets the textString property of this text object.
setText(String) - Method in class jhplot.jadraw.JaText
Sets the textString property of this text object.
setText(String) - Method in class jhplot.jadraw.JaTextBox
Sets the textString property of this text object.
setText(String) - Method in class jhplot.shapes.Text
Set a string with the text
setTextBottom(String, Font, Color) - Method in class jhplot.GHPanel
Sets a text on global bottom margin.
setTextBottom(String, Font) - Method in class jhplot.GHPanel
Sets a text on global bottom margin using black color.
setTextBottom(String) - Method in class jhplot.GHPanel
Set the global bottom margin with default attributes.
setTextBottom(String, double) - Method in class jhplot.GHPanel
Set the global bottom margin with default attributes.
setTextBottomColorBack(Color) - Method in class jhplot.GHPanel
Get the background color of bottom margin
setTextLeft(String, Font, Color) - Method in class jhplot.GHPanel
Sets a text on global left margin
setTextLeft(String, Font) - Method in class jhplot.GHPanel
Sets a text on global left margin using black color.
setTextLeft(String) - Method in class jhplot.GHPanel
Set the global left margin with default attributes.
setTextLeft(String, double) - Method in class jhplot.GHPanel
Set the global left margin with default attributes.
setTextLeftColorBack(Color) - Method in class jhplot.GHPanel
Get the background color of left margin
setTextPosBottomX(double) - Method in class jhplot.GHPanel
Set the text position in X relative to width for bottom margin
setTextPosBottomY(double) - Method in class jhplot.GHPanel
Set the text position in Y relative to width for bottom margin
setTextPosLeftX(double) - Method in class jhplot.GHPanel
Set the text position in X relative to width for left margin
setTextPosLeftY(double) - Method in class jhplot.GHPanel
Set the text position in Y relative to width for left margin
setTextPosRightX(double) - Method in class jhplot.GHPanel
Set the text position in X relative to width for right margin
setTextPosRightY(double) - Method in class jhplot.GHPanel
Set the text position in Y relative to width for right margin
setTextPosTopX(double) - Method in class jhplot.GHPanel
Set the text position in X relative to width for top margin
setTextPosTopY(double) - Method in class jhplot.GHPanel
Set the text position in Y relative to width for top margin
setTextRight(String, Font, Color) - Method in class jhplot.GHPanel
Sets a text on global right margin
setTextRight(String, Font) - Method in class jhplot.GHPanel
Sets a text on global right margin using black color.
setTextRight(String) - Method in class jhplot.GHPanel
Set the global right margin with default attributes.
setTextRight(String, double) - Method in class jhplot.GHPanel
Set the global right margin with default attributes.
setTextRightColorBack(Color) - Method in class jhplot.GHPanel
Get the background color of left margin
setTextRotationBottom(int) - Method in class jhplot.GHPanel
Set the text rotation for bottom margin
setTextRotationLeft(int) - Method in class jhplot.GHPanel
Set the text rotation for left margin
setTextRotationRight(int) - Method in class jhplot.GHPanel
Set the text rotation for right margin
setTextRotationTop(int) - Method in class jhplot.GHPanel
Set the text rotation for top margin
setTextString(String) - Method in class jhplot.jadraw.JaLatexText
Sets the textString property of this text object.
setTextTop(String, Font, Color) - Method in class jhplot.GHPanel
Sets a text on global top margin
setTextTop(String, Font) - Method in class jhplot.GHPanel
Sets a text on global top margin using black color.
setTextTop(String) - Method in class jhplot.GHPanel
Set the global top margin with default attributes.
setTextTopColorBack(Color) - Method in class jhplot.GHPanel
Get the background color of top margin
setTheme(String) - Method in class jhplot.HChart
Set a custom theme for chart..
setTheta(double) - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
Sets the θ associated with this object.
setThetaPhiP(double, double, double) - Method in class hephysics.particle.LParticle
Set HepLorentzVector using theta angle, phi and total momentum.
setTicColor(int, Color) - Method in class jhplot.HPlot
Sets the color used by the labels drawn at each tick.
setTicColor(Color) - Method in class jhplot.HPlot
Sets the color used by the labels drawn at each tick (for all axises).
setTicFont(int, Font) - Method in class jhplot.HPlot
Sets the font used by the labels drawn at each tick.
setTicFont(Font) - Method in class jhplot.HPlot
Sets the font used by the labels drawn at each tick (for all axises).
setTicFont(Font) - Method in class jhplot.HPlot3D
Set font for the ticks
setTicFont(Font) - Method in class jhplot.HPlotJa
Sets the font used by the labels drawn at each tick.
setTicksLabels(int, boolean) - Method in class jhplot.HPlotJa
Set tick labels for the current pad
setTicksLabels(int, boolean) - Method in class jhplot.jadraw.JaAxes
Set or not tick labels
setTicksNumber(int, int) - Method in class jhplot.jadraw.JaAxes
Set the number of main ticks.
setTicksSize(int, double) - Method in class jhplot.jadraw.JaAxes
Set the size of the ticks in NDC format.
setTicksSynchro(int) - Method in class umontreal.iro.lecuyer.charts.EmpiricalChart
Synchronizes x-axis ticks to the s-th series x-values.
setTicksSynchro(int) - Method in class umontreal.iro.lecuyer.charts.HistogramChart
Synchronizes x-axis ticks to the s-th histogram bins.
setTicksSynchro(int) - Method in class umontreal.iro.lecuyer.charts.ScatterChart
Synchronizes X-axis ticks to the s-th series x-values.
setTicksSynchro(int) - Method in class umontreal.iro.lecuyer.charts.XYChart
Synchronizes x-axis ticks to the s-th series x-values.
setTicksSynchro(int) - Method in class umontreal.iro.lecuyer.charts.XYLineChart
Synchronizes X-axis ticks to the s-th series x-values.
setTicLabel(String[][]) - Method in class jhplot.jadraw.JaAxes
 
setTicLabels(boolean) - Method in class jhplot.HPlot
Sets whether all tick-labels will be written or not.
setTicLabels(int, boolean) - Method in class jhplot.HPlot
Sets whether tick-labels will be written or not.
setTicLength(int, double) - Method in class jhplot.HPlot
Sets the length of the ticks.
setTicLength(double) - Method in class jhplot.HPlot
Sets the length of the ticks for all axes.
setTicOffset(double) - Method in class jhplot.HPlot3D
Set tick offset
setTics(int, boolean) - Method in class jhplot.HPlot
Sets whether or not to draw ticks (little lines on the axes).
setTics(boolean) - Method in class jhplot.HPlot
Sets whether or not to draw ticks (little lines on the axes) for all axis.
setTicsMirror(int, boolean) - Method in class jhplot.HPlot
Sets true or false to draw mirror ticks
setTicsMirror(boolean) - Method in class jhplot.HPlot
Sets true or false to draw mirror ticks for X and Y
setTicsRotate(int, boolean) - Method in class jhplot.HPlot
Defines whether we should rotate ticks.
setTime(double) - Method in class umontreal.iro.lecuyer.simevents.Event
Sets the (planned) time of occurence of this event to time.
setTitle(String) - Method in class flanagan.analysis.Regression
 
setTitle(String) - Method in class hep.aida.ref.fitter.InternalFitFunction
 
setTitle(String) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setTitle(String) - Method in class hep.aida.ref.function.AbstractIFunction
 
setTitle(String) - Method in class hep.aida.ref.function.BaseModelFunction
 
setTitle(String) - Method in class hep.aida.ref.function.FunctionCore
 
setTitle(String) - Method in class hep.aida.ref.function.SumOfFunctions
 
setTitle(String) - Method in class hep.aida.ref.histogram.AbstractBaseHistogram
Set the histogram title.
setTitle(String) - Method in class hep.aida.ref.histogram.DataPointSet
 
setTitle(String) - Method in class hep.aida.ref.tuple.AbstractTuple
 
setTitle(String) - Method in class jhplot.DrawOptions
Sets the title
setTitle(String) - Method in class jhplot.F1D
Sets a new title of a function
setTitle(String) - Method in class jhplot.F2D
Set a title
setTitle(String) - Method in class jhplot.F3D
Set a title
setTitle(String) - Method in class jhplot.FND
Sets a name of the function, i.e.
setTitle(String) - Method in class jhplot.FPR
Set a title
setTitle(String) - Method in class jhplot.H1D
Sets the title
setTitle(String) - Method in class jhplot.H2D
Set title
setTitle(String) - Method in class jhplot.H3D
Sets the title
setTitle(String) - Method in class jhplot.HProf1D
Sets the title
setTitle(String) - Method in class jhplot.HProf2D
Set title
setTitle(String) - Method in class jhplot.P0D
Set a new title
setTitle(String) - Method in class jhplot.P0I
Set a new title
setTitle(String) - Method in class jhplot.P1D
Set a new title
setTitle(String) - Method in class jhplot.P2D
Set a new title
setTitle(String) - Method in class jhplot.P3D
Set a new title
setTitle(String) - Method in class jhplot.PND
Set a new title
setTitle(String) - Method in class jhplot.PNI
Set a new title
setTitle(String) - Method in class jhplot.SPlot
Set global title for this plot.
setTitle(String) - Method in class jhpro.stat.DataKeeper
 
setTitle(String) - Method in class umontreal.iro.lecuyer.charts.CategoryChart
Sets a title to this chart.
setTitle(String) - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Sets a title to the chart.
setTitle(String) - Method in class umontreal.iro.lecuyer.charts.XYChart
Sets a title to this chart.
setTitleFont(String) - Method in class jhplot.SPlot
Set the title font.
setTolerance(double) - Method in class cern.colt.matrix.linalg.Property
Sets the tolerance to Math.abs(newTolerance).
setTolerance(double) - Method in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
Sets the tolerance to Math.abs(newTolerance).
setTolerance(double) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Sets the tolerance to Math.abs(newTolerance).
setTolerance(float) - Method in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
Sets the tolerance to Math.abs(newTolerance).
setTolerance(float) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Sets the tolerance to Math.abs(newTolerance).
setTolerance(double) - Method in class flanagan.analysis.Regression
 
setTolerance(double) - Method in class flanagan.math.Maximisation
 
setTolerance(double) - Method in class flanagan.math.Minimisation
 
setToleranceAdditionFactor(double) - Method in class flanagan.integration.RungeKutta
 
setToleranceScalingFactor(double) - Method in class flanagan.integration.RungeKutta
 
setTrans(float, float, float) - Method in class jhplot.v3d.Position
 
setTransparency(float) - Method in class jhplot.jadraw.JaBlob
Set transparency of this object
setTransparency(float) - Method in class jhplot.jadraw.JaBox
Set transparency of this object
setTransparency(float) - Method in class jhplot.jadraw.JaLine
Set transparency of this object
setTransparency(double) - Method in class jhplot.shapes.HShape
Get the transparency level
setTrueFreq(boolean) - Method in class flanagan.analysis.Regression
 
setTSB(double[]) - Method in class jhpro.stat.ConfidenceLevel
 
setTSD(double) - Method in class jhpro.stat.ConfidenceLevel
 
setTSS(double[]) - Method in class jhpro.stat.ConfidenceLevel
 
setTwinAxisPosition(double) - Method in class umontreal.iro.lecuyer.charts.Axis
Defines where the opposite axis must be drawn on the current axis, where it should appear, and on which label.
setTwoDarray(double[][]) - Method in class flanagan.math.Matrix
 
setType(int) - Method in class hep.aida.ref.function.Range
Set the IRange type.
setType(int) - Method in class hephysics.particle.HEParticle
Set type ID
setType(int) - Method in class jhplot.DrawOptions
Set type of the object Should be: LinePars.H1D, LineParsF1D, LineParsF1D
setType(Class) - Method in class jhplot.io.csv.bean.HeaderColumnNameMappingStrategy
 
setType(int) - Method in class jhplot.jadraw.JaKey
Set type of this object
setType(int) - Method in class jhplot.jadraw.JaText
Set identification type for this text label
setType(int) - Method in class jhplot.jadraw.JaTextBox
Set identification number for this text object
setType(int) - Method in class jhplot.shapes.Arrow
Set the type of arrow: 1,2,3
setType(HistogramType) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Sets the histogram type and sends a DatasetChangeEvent to all registered listeners.
setUnknownDistributionChiSquareTest(UnknownDistributionChiSquareTest) - Static method in class org.apache.commons.math.stat.inference.TestUtils
Deprecated. 2.2 will be removed in 3.0 - not compatible with use from multiple threads
setUnmodifiable() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
Forbids any future modification to this list of statistical probes.
setUpper(double) - Method in class jhplot.math.num.pdf.Uniform
Modify the upper bound parameter.
setUpperBound(double) - Method in class hep.aida.ref.fitter.FitParameterSettings
 
setUpperBound(double) - Method in class hep.aida.ref.function.Range
Set the upper bound.
setUpperEdge(double) - Method in class hep.aida.ref.histogram.Cloud1D
Set the Cloud's upper edge
setUpperEdgeX(double) - Method in class hep.aida.ref.histogram.Cloud2D
Set the Cloud's x upper edge
setUpperEdgeX(double) - Method in class hep.aida.ref.histogram.Cloud3D
Set the Cloud's x upper edge
setUpperEdgeY(double) - Method in class hep.aida.ref.histogram.Cloud2D
Set the Cloud's y upper edge
setUpperEdgeY(double) - Method in class hep.aida.ref.histogram.Cloud3D
Set the Cloud's y upper edge
setUpperEdgeZ(double) - Method in class hep.aida.ref.histogram.Cloud3D
Set the Cloud's z upper edge
setUpperLimit(double) - Method in class flanagan.integration.Integration
 
setupperLimit(double) - Method in class flanagan.integration.Integration
 
setUseFunctionGradient(boolean) - Method in class hep.aida.ref.fitter.Fitter
 
setV(double, double, double) - Method in class hephysics.vec.Hep3Vector
Set vector
setV3(Hep3Vector) - Method in class hephysics.vec.HepLorentzVector
Set 3-vector
setV3(double, double, double) - Method in class hephysics.vec.HepLorentzVector
Set 3-vector position or Px,Py,Pz
setVal(double) - Method in class jhplot.math.ValueErr
Set value
setValid(AIDAListener) - Method in class hep.aida.ref.event.AIDAObservable
 
setValid(AIDAListener) - Method in interface hep.aida.ref.event.IsObservable
 
setValidEntries(int) - Method in class hep.aida.ref.histogram.Histogram
 
setValidEntries(int) - Method in class hep.aida.ref.histogram.Profile1D
 
setValidEntries(int) - Method in class hep.aida.ref.histogram.Profile2D
 
setValidEntries(int) - Method in class jhplot.H1D
Sets number of valid entries.
setValidEntries(int) - Method in class jhplot.H2D
Set in-range entries.
setValidEntries(int) - Method in class jhplot.HProf1D
Sets number of valid entries.
setValidEntries(int) - Method in class jhplot.HProf2D
Set in-range entries.
setValidForAll() - Method in class hep.aida.ref.event.AIDAObservable
 
setValue(double) - Method in class flanagan.analysis.ErrorProp
 
setValue(String, String) - Method in class hep.aida.ref.Annotation
Set value for a given key.
setValue(double) - Method in class hep.aida.ref.histogram.Measurement
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnBoolean
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnByte
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnChar
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnDouble
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFloat
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnInt
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnLong
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnObject
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnShort
 
setValue(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnString
 
setValue(int, double) - Method in class jhpro.stat.DataKeeper
Set a value at index
setValue(double) - Method in class org.apache.commons.math.linear.RealVector.Entry
Set the value of the entry.
setValueAt(Object, int, int) - Method in class jhplot.SPsheet
This method sets the value of the cell specified with these coordinates to aValue.
setValues(double[]) - Method in class jhpro.stat.DataKeeper
 
setValues(int, List) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Sets the values for a series.
setValues(int, double[]) - Method in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
Sets the values for a series.
setValues(int, List) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Sets a new values set to a series from a List variable.
setValues(int, double[]) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
Sets a new values set to a series from a table.
setValuesFileURL(String) - Method in class org.apache.commons.math.random.ValueServer
Sets the valuesFileURL using a string URL representation
setValuesFileURL(URL) - Method in class org.apache.commons.math.random.ValueServer
Sets the valuesFileURL
setVar(double[]) - Method in class hep.aida.ref.function.JELCompiledExpression.ValueProvider
 
setVariableNames(String[]) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
setVarianceDirection(SemiVariance.Direction) - Method in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
Sets the variance direction
setVarianceImpl(UnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Sets the implementation for the variance.
setVarianceImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Sets the implementation for the variance.
setVarianceImpl(StorelessUnivariateStatistic) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Sets the implementation for the variance.
setVarimaxMaximumIterations(int) - Method in class flanagan.analysis.PCA
 
setVarimaxTolerance(double) - Method in class flanagan.analysis.PCA
 
setVertexPts(double, double, double, double, double, double) - Method in class jhplot.jadraw.JaVertexT5
Sets the points of this vertex.
setWeight(int) - Method in class cern.jet.random.sampling.WeightedRandomSampler
Not yet commented.
setWeight(int) - Method in class cern.jet.random.tdouble.sampling.WeightedDoubleRandomSampler
Not yet commented.
setWeight(int) - Method in class cern.jet.random.tfloat.sampling.WeightedFloatRandomSampler
Not yet commented.
setWeights(double[]) - Method in class flanagan.analysis.Stat
 
setWeights(Double[]) - Method in class flanagan.analysis.Stat
 
setWeights(float[]) - Method in class flanagan.analysis.Stat
 
setWeights(Float[]) - Method in class flanagan.analysis.Stat
 
setWeights(long[]) - Method in class flanagan.analysis.Stat
 
setWeights(Long[]) - Method in class flanagan.analysis.Stat
 
setWeights(int[]) - Method in class flanagan.analysis.Stat
 
setWeights(Integer[]) - Method in class flanagan.analysis.Stat
 
setWeights(short[]) - Method in class flanagan.analysis.Stat
 
setWeights(Short[]) - Method in class flanagan.analysis.Stat
 
setWeights(byte[]) - Method in class flanagan.analysis.Stat
 
setWeights(Byte[]) - Method in class flanagan.analysis.Stat
 
setWeights(BigDecimal[]) - Method in class flanagan.analysis.Stat
 
setWeights(BigInteger[]) - Method in class flanagan.analysis.Stat
 
setWeights(Complex[]) - Method in class flanagan.analysis.Stat
 
setWeights(Phasor[]) - Method in class flanagan.analysis.Stat
 
setWeights(Object[]) - Method in class flanagan.analysis.Stat
 
setWeights(Vector<Object>) - Method in class flanagan.analysis.Stat
 
setWeights(ArrayList<Object>) - Method in class flanagan.analysis.Stat
 
setWeightsToBigW() - Method in class flanagan.analysis.Stat
 
setWeightsToLittleW() - Method in class flanagan.analysis.Stat
 
setWelch() - Method in class flanagan.math.FourierTransform
 
setWhoAm(int) - Method in class jhplot.shapes.HShape
Set primitive type
setWholeFormat(NumberFormat) - Method in class org.apache.commons.math.fraction.ProperBigFractionFormat
Modify the whole format.
setWholeFormat(NumberFormat) - Method in class org.apache.commons.math.fraction.ProperFractionFormat
Modify the whole format.
setWindowSize(int) - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
WindowSize controls the number of values which contribute to the reported statistics.
setWindowSize(int) - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
WindowSize controls the number of values which contribute to the reported statistics.
setWrap(boolean) - Method in class jhplot.SPlot
Specify whether the X axis is wrapped.
setX(double) - Method in class hephysics.vec.Hep3Vector
Set X component
setX(int) - Method in class jhplot.jadraw.JaObject
Sets the x coordinate of this object.
setX0(double) - Method in class umontreal.iro.lecuyer.stochprocess.StochasticProcess
Sets the initial value X(t0) for this process to s0, and reinitializes.
setX1(int) - Method in class jhplot.jadraw.JaArcObject
Sets the x coordinate of the first click point of this arc.
setX1(double) - Method in class jhplot.jadraw.JaVertexT5
Sets the x coordinate of the first click point of this vertex.
setX2(int) - Method in class jhplot.jadraw.JaArcObject
Sets the x coordinate of the second click point of this arc.
setX2(double) - Method in class jhplot.jadraw.JaVertexT5
Sets the x coordinate of the second click point of this vertex.
setX3(double) - Method in class jhplot.jadraw.JaVertexT5
Sets the x coordinate of the third click point of this vertex.
setXinf(double) - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Sets the value xa = xa, such that the probability density is 0 everywhere outside the interval [xa, xb].
setXlegend(String) - Method in class flanagan.analysis.Regression
 
setXLog(boolean) - Method in class jhplot.SPlot
Specify whether the X axis is drawn with a logarithmic scale.
setXRange(double, double) - Method in class jhplot.SPlot
Set the X (horizontal) range of the plot.
setXsup(double) - Method in class umontreal.iro.lecuyer.probdist.ContinuousDistribution
Sets the value xb = xb, such that the probability density is 0 everywhere outside the interval [xa, xb].
setY(double) - Method in class hephysics.vec.Hep3Vector
Y component
setY(int) - Method in class jhplot.jadraw.JaObject
Sets the y coordinate of this object.
setY1(int) - Method in class jhplot.jadraw.JaArcObject
Sets the y coordinate of the first click point of this arc.
setY1(double) - Method in class jhplot.jadraw.JaVertexT5
Sets the y coordinate of the first click point of this vertex.
setY2(int) - Method in class jhplot.jadraw.JaArcObject
Sets the y coordinate of the second click point of this arc.
setY2(double) - Method in class jhplot.jadraw.JaVertexT5
Sets the y coordinate of the second click point of this vertex.
setY3(double) - Method in class jhplot.jadraw.JaVertexT5
Sets the y coordinate of the third click point of this vertex.
setYlegend(String) - Method in class flanagan.analysis.Regression
 
setYLog(boolean) - Method in class jhplot.SPlot
Specify whether the Y axis is drawn with a logarithmic scale.
setYRange(double, double) - Method in class jhplot.SPlot
Set the Y (vertical) range of the plot.
setYscale(boolean) - Method in class flanagan.analysis.Regression
 
setYscaleFactor(double) - Method in class flanagan.analysis.Regression
 
setYscaleOption(boolean) - Method in class flanagan.analysis.Regression
 
setZ(double) - Method in class hephysics.vec.Hep3Vector
Set Z component
setZeroOverZeroValue(double) - Method in class umontreal.iro.lecuyer.util.RatioFunction
Sets the value returned by evaluate for the undefined function 0/0 to zeroOverZero.
setZoomIn(double) - Method in class jhplot.HView3D
Zoom in the current plot.
setZoomOut(double) - Method in class jhplot.HView3D
Zoom out the current plot.
SEVEN - Static variable in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
A Property object with tolerance()==1.0E-7.
SEVEN - Static variable in class cern.colt.matrix.tfloat.algo.FloatProperty
A Property object with tolerance()==1.0E-7.
sgbbrd(String, int, int, int, int, int, float[], int, float[], float[], float[], int, float[], int, float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgbcon(String, int, int, int, float[], int, int[], float, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgbequ(int, int, int, int, float[], int, float[], float[], floatW, floatW, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
sgbmv(String, int, int, int, int, float, float[], int, float[], int, float, float[], int) - Method in class org.netlib.blas.BLAS
..
sgbrfs(String, int, int, int, int, float[], int, float[], int, int[], float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgbsv(int, int, int, int, float[], int, int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgbsvx(String, String, int, int, int, int, float[], int, float[], int, int[], StringW, float[], float[], float[], int, float[], int, floatW, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgbtf2(int, int, int, int, float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgbtrf(int, int, int, int, float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgbtrs(String, int, int, int, int, float[], int, int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgebak(String, String, int, int, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgebal(String, int, float[], int, intW, intW, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgebd2(int, int, float[], int, float[], float[], float[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgebrd(int, int, float[], int, float[], float[], float[], float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgecon(String, int, float[], int, float, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgeequ(int, int, float[], int, float[], float[], floatW, floatW, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
sgees(String, String, Object, int, float[], int, intW, float[], float[], float[], int, float[], int, boolean[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgeesx(String, String, Object, String, int, float[], int, intW, float[], float[], float[], int, floatW, floatW, float[], int, int[], int, boolean[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgeev(String, String, int, float[], int, float[], float[], float[], int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgeevx(String, String, String, String, int, float[], int, float[], float[], float[], int, float[], int, intW, intW, float[], floatW, float[], float[], float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgegs(String, String, int, float[], int, float[], int, float[], float[], float[], float[], int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgegv(String, String, int, float[], int, float[], int, float[], float[], float[], float[], int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgehd2(int, int, int, float[], int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgehrd(int, int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgelq2(int, int, float[], int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgelqf(int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgels(String, int, int, int, float[], int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgelsd(int, int, int, float[], int, float[], int, float[], float, intW, float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgelss(int, int, int, float[], int, float[], int, float[], float, intW, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgelsx(int, int, int, float[], int, float[], int, int[], float, intW, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgelsy(int, int, int, float[], int, float[], int, int[], float, intW, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgemm(String, String, int, int, int, float, float[], int, float[], int, float, float[], int) - Method in class org.netlib.blas.BLAS
..
sgemv(String, int, int, float, float[], int, float[], int, float, float[], int) - Method in class org.netlib.blas.BLAS
..
sgeql2(int, int, float[], int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgeqlf(int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgeqp3(int, int, float[], int, int[], float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgeqpf(int, int, float[], int, int[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgeqr2(int, int, float[], int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgeqrf(int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sger(int, int, float, float[], int, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
sgerfs(String, int, int, float[], int, float[], int, int[], float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgerq2(int, int, float[], int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgerqf(int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgesc2(int, float[], int, float[], int[], int[], floatW) - Method in class org.netlib.lapack.LAPACK
..
sgesdd(String, int, int, float[], int, float[], float[], int, float[], int, float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgesv(int, int, float[], int, int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgesvd(String, String, int, int, float[], int, float[], float[], int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgesvx(String, String, int, int, float[], int, float[], int, int[], StringW, float[], float[], float[], int, float[], int, floatW, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgetc2(int, float[], int, int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgetf2(int, int, float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgetrf(int, int, float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgetri(int, float[], int, int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgetrs(String, int, int, float[], int, int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgetv0(intW, String, int, boolean, int, int, float[], int, float[], floatW, int[], float[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
sggbak(String, String, int, int, int, float[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sggbal(String, int, float[], int, float[], int, intW, intW, float[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgges(String, String, String, Object, int, float[], int, float[], int, intW, float[], float[], float[], float[], int, float[], int, float[], int, boolean[], intW) - Method in class org.netlib.lapack.LAPACK
..
sggesx(String, String, String, Object, String, int, float[], int, float[], int, intW, float[], float[], float[], float[], int, float[], int, float[], float[], float[], int, int[], int, boolean[], intW) - Method in class org.netlib.lapack.LAPACK
..
sggev(String, String, int, float[], int, float[], int, float[], float[], float[], float[], int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sggevx(String, String, String, String, int, float[], int, float[], int, float[], float[], float[], float[], int, float[], int, intW, intW, float[], float[], floatW, floatW, float[], float[], float[], int, int[], boolean[], intW) - Method in class org.netlib.lapack.LAPACK
..
sggglm(int, int, int, float[], int, float[], int, float[], float[], float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgghrd(String, String, int, int, int, float[], int, float[], int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgglse(int, int, int, float[], int, float[], int, float[], float[], float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sggqrf(int, int, int, float[], int, float[], float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sggrqf(int, int, int, float[], int, float[], float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sggsvd(String, String, String, int, int, int, intW, intW, float[], int, float[], int, float[], float[], float[], int, float[], int, float[], int, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sggsvp(String, String, String, int, int, int, float[], int, float[], int, float, float, intW, intW, float[], int, float[], int, float[], int, int[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgtcon(String, int, float[], float[], float[], float[], int[], float, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgtrfs(String, int, int, float[], float[], float[], float[], float[], float[], float[], int[], float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgtsv(int, int, float[], float[], float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgtsvx(String, String, int, int, float[], float[], float[], float[], float[], float[], float[], int[], float[], int, float[], int, floatW, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgttrf(int, float[], float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sgttrs(String, int, int, float[], float[], float[], float[], int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sgtts2(int, int, int, float[], float[], float[], float[], int[], float[], int) - Method in class org.netlib.lapack.LAPACK
..
shannonEntropy() - Method in class flanagan.analysis.Stat
 
shannonEntropy(double[]) - Static method in class flanagan.analysis.Stat
 
shannonEntropyBit() - Method in class flanagan.analysis.Stat
 
shannonEntropyBit(double[]) - Static method in class flanagan.analysis.Stat
 
shannonEntropyDit() - Method in class flanagan.analysis.Stat
 
shannonEntropyDit(double[]) - Static method in class flanagan.analysis.Stat
 
shannonEntropyNat() - Method in class flanagan.analysis.Stat
 
shannonEntropyNat(double[]) - Static method in class flanagan.analysis.Stat
 
shape(AbstractMatrix1D) - Static method in class cern.colt.matrix.AbstractFormatter
Returns a short string representation describing the shape of the matrix.
shape(AbstractMatrix2D) - Static method in class cern.colt.matrix.AbstractFormatter
Returns a short string representation describing the shape of the matrix.
shape(AbstractMatrix3D) - Static method in class cern.colt.matrix.AbstractFormatter
Returns a short string representation describing the shape of the matrix.
shape(AbstractMatrix1D) - Static method in class cern.colt.matrix.impl.AbstractFormatter
Returns a short string representation describing the shape of the matrix.
shape(AbstractMatrix2D) - Static method in class cern.colt.matrix.impl.AbstractFormatter
Returns a short string representation describing the shape of the matrix.
shape(AbstractMatrix3D) - Static method in class cern.colt.matrix.impl.AbstractFormatter
Returns a short string representation describing the shape of the matrix.
shgeqz(String, String, String, int, int, int, float[], int, float[], int, float[], float[], float[], float[], int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
shift(double) - Method in class jhplot.H1D
Shift all bins by some value
shift(double) - Method in class jhplot.HProf1D
Shift all bins by some value
shift() - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Shift one step forward.
shift(int) - Method in class umontreal.iro.lecuyer.util.BitVector
Returns a BitVector equal to the original with all the bits shifted j positions to the right if j is positive, and shifted j positions to the left if j is negative.
ShiftedMathFunction - Class in umontreal.iro.lecuyer.functions
Represents a function computing f (x) - δ for a user-defined function f (x) and shift δ.
ShiftedMathFunction(MathFunction, double) - Constructor for class umontreal.iro.lecuyer.functions.ShiftedMathFunction
Constructs a new function shifting the function func by a shift delta.
shiftedStandardizedOriginalata() - Method in class flanagan.analysis.BoxCox
 
shiftLeft - Static variable in class cern.jet.math.IntFunctions
Function that returns a << b.
shiftLeft(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a << b.
shiftLeft - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a << b.
shiftLeft(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a << b.
shiftLeft - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a << b.
shiftLeft(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a << b.
shiftRightSigned - Static variable in class cern.jet.math.IntFunctions
Function that returns a >> b.
shiftRightSigned(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a >> b.
shiftRightSigned - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a >> b.
shiftRightSigned(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a >> b.
shiftRightSigned - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a >> b.
shiftRightSigned(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a >> b.
shiftRightUnsigned - Static variable in class cern.jet.math.IntFunctions
Function that returns a >>> b.
shiftRightUnsigned(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a >>> b.
shiftRightUnsigned - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a >>> b.
shiftRightUnsigned(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a >>> b.
shiftRightUnsigned - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a >>> b.
shiftRightUnsigned(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a >>> b.
ShortArrayList - Class in cern.colt.list
Resizable list holding short elements; implemented with arrays.
ShortArrayList() - Constructor for class cern.colt.list.ShortArrayList
Constructs an empty list.
ShortArrayList(short[]) - Constructor for class cern.colt.list.ShortArrayList
Constructs a list containing the specified elements.
ShortArrayList(int) - Constructor for class cern.colt.list.ShortArrayList
Constructs an empty list with the specified initial capacity.
ShortArrayList - Class in cern.colt.list.tshort
Resizable list holding short elements; implemented with arrays.
ShortArrayList() - Constructor for class cern.colt.list.tshort.ShortArrayList
Constructs an empty list.
ShortArrayList(short[]) - Constructor for class cern.colt.list.tshort.ShortArrayList
Constructs a list containing the specified elements.
ShortArrayList(int) - Constructor for class cern.colt.list.tshort.ShortArrayList
Constructs an empty list with the specified initial capacity.
ShortBuffer - Class in cern.colt.buffer.tshort
Fixed sized (non resizable) streaming buffer connected to a target ShortBufferConsumer to which data is automatically flushed upon buffer overflow.
ShortBuffer(ShortBufferConsumer, int) - Constructor for class cern.colt.buffer.tshort.ShortBuffer
Constructs and returns a new buffer with the given target.
ShortBuffer2D - Class in cern.colt.buffer.tshort
Fixed sized (non resizable) streaming buffer connected to a target ShortBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
ShortBuffer2D(ShortBuffer2DConsumer, int) - Constructor for class cern.colt.buffer.tshort.ShortBuffer2D
Constructs and returns a new buffer with the given target.
ShortBuffer2DConsumer - Interface in cern.colt.buffer.tshort
Target of a streaming ShortBuffer2D into which data is flushed upon buffer overflow.
ShortBuffer3D - Class in cern.colt.buffer.tshort
Fixed sized (non resizable) streaming buffer connected to a target ShortBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
ShortBuffer3D(ShortBuffer3DConsumer, int) - Constructor for class cern.colt.buffer.tshort.ShortBuffer3D
Constructs and returns a new buffer with the given target.
ShortBuffer3DConsumer - Interface in cern.colt.buffer.tshort
Target of a streaming ShortBuffer3D into which data is flushed upon buffer overflow.
ShortBufferConsumer - Interface in cern.colt.buffer.tshort
Target of a streaming ShortBuffer into which data is flushed upon buffer overflow.
ShortComparator - Interface in cern.colt.function
A comparison function which imposes a total ordering on some collection of elements.
ShortComparator - Interface in cern.colt.function.tshort
A comparison function which imposes a total ordering on some collection of elements.
ShortProcedure - Interface in cern.colt.function
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
ShortProcedure - Interface in cern.colt.function.tshort
Interface that represents a procedure object: a procedure that takes a single argument and does not return a value.
shortReport() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
 
shortReport() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Formats and returns a short, one-line report about this statistical probe.
shortReport() - Method in class umontreal.iro.lecuyer.stat.Tally
Formats and returns a short statistical report for this tally.
shortReportHeader() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
 
shortReportHeader() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Returns a string containing the name of the values returned in the report strings.
shortReportHeader() - Method in class umontreal.iro.lecuyer.stat.Tally
 
shortTime(double) - Method in class flanagan.math.FourierTransform
 
shortTime(int) - Method in class flanagan.math.FourierTransform
 
shortTOdouble(short[]) - Static method in class flanagan.math.Fmath
 
shortTOfloat(short[]) - Static method in class flanagan.math.Fmath
 
shortTOint(short[]) - Static method in class flanagan.math.Fmath
 
shortTOlong(short[]) - Static method in class flanagan.math.Fmath
 
shouldBeInterpreted(Method) - Method in class umontreal.iro.lecuyer.simprocs.SSJInterpretationOracle
 
show() - Method in class jhplot.HNeuralNet
Show Net in EncodeDocument.
show(H1D) - Method in class jhplot.HTable
Show a H1D histogram.
show(F1D) - Method in class jhplot.HTable
Show a function
show(P0D) - Method in class jhplot.HTable
show P0D data
show(P1D) - Method in class jhplot.HTable
Show P1D data
show(P2D) - Method in class jhplot.HTable
show P2D data
show(P3D) - Method in class jhplot.HTable
show P3D data
showAllGraph(boolean) - Method in class jhplot.HPlot
Set the all graphs visible or not
showAttributes() - Method in class jminhep.cluster.DataPoint
Print all attributes of a data point
showAxis(int) - Method in class jhplot.HPlotJa
Show a particular axis (no mirror)
showBorder(boolean) - Method in class jhplot.GHMargin
Show or not the blue borders during editing.
showBorderNoUpdate(boolean) - Method in class jhplot.GHMargin
Show or not the blue borders during editing.
showBorders(boolean) - Method in class jhplot.GHPanel
Show borders of margins for edditing
showBrowser(String) - Method in class jhplot.HPlotJa
Show a browser with objects loaded from ROOT or AIDA objects.
showEditor() - Method in class jhplot.HPlotJa
Show object editor on the left of the canvas.
showEditor(boolean) - Method in class jhplot.HPlotJa
Show object editor (or not)
showGraph(boolean) - Method in class jhplot.HPlot
Set the current graph visible or not
showIt(boolean) - Method in class jhplot.io.HFileBrowser
Show the browser on the left of Canvas.
showIt(boolean) - Method in class jhplot.io.PFileBrowser
Show the browser on the left of Canvas.
showKey(boolean) - Method in class jhplot.HPlotJa
Show or not keys for the current plot
showMessage(String) - Static method in class jhplot.JHPlot
Show a text on status bar permanently.
showMouse(String, double, double, double, double) - Static method in class jhplot.JHPlot
Show mouse positions
showNetwork() - Method in class jhplot.HNeuralNet
Show a neural net in a frame
showStatusBarText(String) - Static method in class jhplot.JHPlot
Show a text on status bar for 5 sec.
showTest() - Method in class jhplot.HPlot2D
 
SHPlot - Class in jhplot
A class to create a 2D canvas with several plots.
SHPlot3D - Class in jhplot
A class to create a 3D canvas to display H2D and F2D objects.
SHPlotJa - Class in jhplot
A class to create a canvas with several plots and Feynman diagrams.
shroveTuesday() - Method in class flanagan.math.TimeAndDate
 
shroveTuesday(int) - Method in class flanagan.math.TimeAndDate
 
shsein(String, String, String, boolean[], int, float[], int, float[], float[], float[], int, float[], int, int, intW, float[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
shseqr(String, String, int, int, int, float[], int, float[], float[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
shuffle() - Method in class cern.colt.list.AbstractList
Randomly permutes the receiver.
shuffle(List<?>, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
 
shuffle(Object[], RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Randomly permutes array using stream.
shuffle(byte[], RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Randomly permutes array using stream.
shuffle(short[], RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(byte[], RandomStream).
shuffle(int[], RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(byte[], RandomStream).
shuffle(long[], RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(byte[], RandomStream).
shuffle(char[], RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(byte[], RandomStream).
shuffle(boolean[], RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(byte[], RandomStream).
shuffle(float[], RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(byte[], RandomStream).
shuffle(double[], RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(byte[], RandomStream).
shuffle(List<?>, int, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
 
shuffle(Object[], int, int, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Partially permutes array as follows using stream: draws the new k elements, array[0] to array[k-1], randomly among the old n elements, array[0] to array[n-1], assuming that k <= n <=  array.length.
shuffle(byte[], int, int, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(Object[], n, k, RandomStream).
shuffle(short[], int, int, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(Object[], n, k, RandomStream).
shuffle(int[], int, int, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(Object[], n, k, RandomStream).
shuffle(long[], int, int, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(Object[], n, k, RandomStream).
shuffle(char[], int, int, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(Object[], n, k, RandomStream).
shuffle(boolean[], int, int, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(Object[], n, k, RandomStream).
shuffle(float[], int, int, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(Object[], n, k, RandomStream).
shuffle(double[], int, int, RandomStream) - Static method in class umontreal.iro.lecuyer.rng.RandomPermutation
Similar to shuffle(Object[], n, k, RandomStream).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractBooleanList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractByteList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractCharList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractDoubleList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractFloatList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractIntList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractList
Randomly permutes the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractLongList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.AbstractShortList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.ByteArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.CharArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.DoubleArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.FloatArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.IntArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.LongArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.ObjectArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.ShortArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tbyte.AbstractByteList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tbyte.ByteArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tchar.AbstractCharList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tchar.CharArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tdouble.DoubleArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tfloat.FloatArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tint.AbstractIntList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tint.IntArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tlong.AbstractLongList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tlong.LongArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tobject.ObjectArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tshort.AbstractShortList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
shuffleFromTo(int, int) - Method in class cern.colt.list.tshort.ShortArrayList
Randomly permutes the part of the receiver between from (inclusive) and to (inclusive).
sigmoidHillSips() - Method in class flanagan.analysis.Regression
 
sigmoidHillSipsPlot() - Method in class flanagan.analysis.Regression
 
sigmoidThreshold() - Method in class flanagan.analysis.Regression
 
sigmoidThresholdPlot() - Method in class flanagan.analysis.Regression
 
sign - Static variable in class cern.jet.math.Functions
Function that returns a < 0 ? -1 : a > 0 ? 1 : 0.
sign - Static variable in class cern.jet.math.IntFunctions
Function that returns a < 0 ? -1 : a > 0 ? 1 : 0.
sign - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a < 0 ? -1 : a > 0 ? 1 : 0.
sign - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a < 0 ? -1 : a > 0 ? 1 : 0.
sign - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a < 0 ? -1 : a > 0 ? 1 : 0.
sign - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a < 0 ? -1 : a > 0 ? 1 : 0.
sign(double) - Static method in class flanagan.math.Fmath
 
sign(float) - Static method in class flanagan.math.Fmath
 
sign(int) - Static method in class flanagan.math.Fmath
 
sign(long) - Static method in class flanagan.math.Fmath
 
sign(double, double) - Static method in class hep.aida.ref.function.GaussianCore2DNorm
 
sign(byte) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for byte value x.
sign(double) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for double precision x.
sign(float) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for float value x.
sign(int) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for int value x.
sign(long) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for long value x.
sign(short) - Static method in class org.apache.commons.math.util.MathUtils
Returns the sign for short value x.
SIGNUM - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.signum method wrapped as a ComposableFunction.
signum(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the signum of a number.
signum(float) - Static method in class org.apache.commons.math.util.FastMath
Compute the signum of a number.
Sim - Class in umontreal.iro.lecuyer.simevents
This static class contains the executive of a discrete-event simulation.
SimpleEstimationProblem - Class in org.apache.commons.math.estimation
Deprecated. as of 2.0, everything in package org.apache.commons.math.estimation has been deprecated and replaced by package org.apache.commons.math.optimization.general
SimpleEstimationProblem() - Constructor for class org.apache.commons.math.estimation.SimpleEstimationProblem
Deprecated. Build an empty instance without parameters nor measurements.
SimpleLongArrayList - Class in cern.colt.list
Resizable list holding long elements; implemented with arrays; not efficient; just to demonstrate which methods you must override to implement a fully functional list.
SimpleLongArrayList() - Constructor for class cern.colt.list.SimpleLongArrayList
Constructs an empty list.
SimpleLongArrayList(long[]) - Constructor for class cern.colt.list.SimpleLongArrayList
Constructs a list containing the specified elements.
SimpleLongArrayList(int) - Constructor for class cern.colt.list.SimpleLongArrayList
Constructs an empty list with the specified initial capacity.
SimpleLongArrayList - Class in cern.colt.list.tlong
Resizable list holding long elements; implemented with arrays; not efficient; just to demonstrate which methods you must override to implement a fully functional list.
SimpleLongArrayList() - Constructor for class cern.colt.list.tlong.SimpleLongArrayList
Constructs an empty list.
SimpleLongArrayList(long[]) - Constructor for class cern.colt.list.tlong.SimpleLongArrayList
Constructs a list containing the specified elements.
SimpleLongArrayList(int) - Constructor for class cern.colt.list.tlong.SimpleLongArrayList
Constructs an empty list with the specified initial capacity.
SimpleMD5 - Class in jhplot.security
 
SimpleMD5() - Constructor for class jhplot.security.SimpleMD5
 
SimpleRealPointChecker - Class in org.apache.commons.math.optimization
Simple implementation of the RealConvergenceChecker interface using only point coordinates.
SimpleRealPointChecker() - Constructor for class org.apache.commons.math.optimization.SimpleRealPointChecker
Build an instance with default threshold.
SimpleRealPointChecker(double, double) - Constructor for class org.apache.commons.math.optimization.SimpleRealPointChecker
Build an instance with a specified threshold.
SimpleRegression - Class in org.apache.commons.math.stat.regression
Estimates an ordinary least squares regression model with one independent variable.
SimpleRegression() - Constructor for class org.apache.commons.math.stat.regression.SimpleRegression
Create an empty SimpleRegression instance
SimpleRegression(TDistribution) - Constructor for class org.apache.commons.math.stat.regression.SimpleRegression
Deprecated. in 2.2 (to be removed in 3.0). Please use the other constructor instead.
SimpleRegression(int) - Constructor for class org.apache.commons.math.stat.regression.SimpleRegression
Create an empty SimpleRegression.
SimpleScalarValueChecker - Class in org.apache.commons.math.optimization
Simple implementation of the RealConvergenceChecker interface using only objective function values.
SimpleScalarValueChecker() - Constructor for class org.apache.commons.math.optimization.SimpleScalarValueChecker
Build an instance with default threshold.
SimpleScalarValueChecker(double, double) - Constructor for class org.apache.commons.math.optimization.SimpleScalarValueChecker
Build an instance with a specified threshold.
SimpleVectorialPointChecker - Class in org.apache.commons.math.optimization
Simple implementation of the VectorialConvergenceChecker interface using only point coordinates.
SimpleVectorialPointChecker() - Constructor for class org.apache.commons.math.optimization.SimpleVectorialPointChecker
Build an instance with default threshold.
SimpleVectorialPointChecker(double, double) - Constructor for class org.apache.commons.math.optimization.SimpleVectorialPointChecker
Build an instance with a specified threshold.
SimpleVectorialValueChecker - Class in org.apache.commons.math.optimization
Simple implementation of the VectorialConvergenceChecker interface using only objective function values.
SimpleVectorialValueChecker() - Constructor for class org.apache.commons.math.optimization.SimpleVectorialValueChecker
Build an instance with default threshold.
SimpleVectorialValueChecker(double, double) - Constructor for class org.apache.commons.math.optimization.SimpleVectorialValueChecker
Build an instance with a specified threshold.
simplex(RegressionFunction, double[], double[], double, int) - Method in class flanagan.analysis.Regression
 
simplex(RegressionFunction, double[], double[], double) - Method in class flanagan.analysis.Regression
 
simplex(RegressionFunction, double[], double[], int) - Method in class flanagan.analysis.Regression
 
simplex(RegressionFunction, double[], double[]) - Method in class flanagan.analysis.Regression
 
simplex(RegressionFunction, double[], double, int) - Method in class flanagan.analysis.Regression
 
simplex(RegressionFunction, double[], double) - Method in class flanagan.analysis.Regression
 
simplex(RegressionFunction, double[], int) - Method in class flanagan.analysis.Regression
 
simplex(RegressionFunction, double[]) - Method in class flanagan.analysis.Regression
 
simplex2(RegressionFunction2, double[], double[], double, int) - Method in class flanagan.analysis.Regression
 
simplex2(RegressionFunction2, double[], double[], double) - Method in class flanagan.analysis.Regression
 
simplex2(RegressionFunction2, double[], double[], int) - Method in class flanagan.analysis.Regression
 
simplex2(RegressionFunction2, double[], double[]) - Method in class flanagan.analysis.Regression
 
simplex2(RegressionFunction2, double[], double, int) - Method in class flanagan.analysis.Regression
 
simplex2(RegressionFunction2, double[], double) - Method in class flanagan.analysis.Regression
 
simplex2(RegressionFunction2, double[], int) - Method in class flanagan.analysis.Regression
 
simplex2(RegressionFunction2, double[]) - Method in class flanagan.analysis.Regression
 
simplexPlot(RegressionFunction, double[], double[], double, int) - Method in class flanagan.analysis.Regression
 
simplexPlot(RegressionFunction, double[], double[], double) - Method in class flanagan.analysis.Regression
 
simplexPlot(RegressionFunction, double[], double[], int) - Method in class flanagan.analysis.Regression
 
simplexPlot(RegressionFunction, double[], double[]) - Method in class flanagan.analysis.Regression
 
simplexPlot(RegressionFunction, double[], double, int) - Method in class flanagan.analysis.Regression
 
simplexPlot(RegressionFunction, double[], double) - Method in class flanagan.analysis.Regression
 
simplexPlot(RegressionFunction, double[], int) - Method in class flanagan.analysis.Regression
 
simplexPlot(RegressionFunction, double[]) - Method in class flanagan.analysis.Regression
 
simplexPlot2(RegressionFunction2, double[], double[], double, int) - Method in class flanagan.analysis.Regression
 
simplexPlot2(RegressionFunction2, double[], double[], double) - Method in class flanagan.analysis.Regression
 
simplexPlot2(RegressionFunction2, double[], double[], int) - Method in class flanagan.analysis.Regression
 
simplexPlot2(RegressionFunction2, double[], double[]) - Method in class flanagan.analysis.Regression
 
simplexPlot2(RegressionFunction2, double[], double, int) - Method in class flanagan.analysis.Regression
 
simplexPlot2(RegressionFunction2, double[], double) - Method in class flanagan.analysis.Regression
 
simplexPlot2(RegressionFunction2, double[], int) - Method in class flanagan.analysis.Regression
 
simplexPlot2(RegressionFunction2, double[]) - Method in class flanagan.analysis.Regression
 
SimplexSolver - Class in org.apache.commons.math.optimization.linear
Solves a linear problem using the Two-Phase Simplex Method.
SimplexSolver() - Constructor for class org.apache.commons.math.optimization.linear.SimplexSolver
Build a simplex solver with default settings.
SimplexSolver(double) - Constructor for class org.apache.commons.math.optimization.linear.SimplexSolver
Build a simplex solver with a specified accepted amount of error
simplify() - Method in class jhplot.FND
Treat the function as complex.
SimProcess - Class in umontreal.iro.lecuyer.simprocs
This abstract class provides process scheduling tools.
SimProcess() - Constructor for class umontreal.iro.lecuyer.simprocs.SimProcess
Constructs a new process without scheduling it and associates this new process with the default simulator; one can get additional knowledge with Simulator static methods.
SimProcess(ProcessSimulator) - Constructor for class umontreal.iro.lecuyer.simprocs.SimProcess
Constructs a new process associated with sim without scheduling it.
simpson(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using Simpson's rule.
simpsonIntegral(MathFunction, double, double, int) - Static method in class umontreal.iro.lecuyer.functions.MathFunctionUtil
Computes and returns an approximation of the integral of func over [a, b], using the Simpson's 1/3 method with numIntervals intervals.
SimpsonIntegrator - Class in org.apache.commons.math.analysis.integration
Implements the Simpson's Rule for integration of real univariate functions.
SimpsonIntegrator(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.integration.SimpsonIntegrator
Deprecated. as of 2.0 the integrand function is passed as an argument to the SimpsonIntegrator.integrate(UnivariateRealFunction, double, double)method.
SimpsonIntegrator() - Constructor for class org.apache.commons.math.analysis.integration.SimpsonIntegrator
Construct an integrator.
SimpsonsIntegrator - Class in jhplot.math.num.integration
The extended Simpson's rule for numerically integrating functions.
SimpsonsIntegrator(Function) - Constructor for class jhplot.math.num.integration.SimpsonsIntegrator
Create an integrator for the given function.
SimpsonsIntegrator(Function, int, double) - Constructor for class jhplot.math.num.integration.SimpsonsIntegrator
Create an integrator for the given function.
simulator() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Returns the simulator associated with this statistical probe.
simulator() - Method in class umontreal.iro.lecuyer.simevents.Continuous
Returns the simulator linked to this continuous-time variable.
simulator() - Method in class umontreal.iro.lecuyer.simevents.Event
Returns the simulator linked to this event.
simulator() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
Returns the simulator associated with this list.
Simulator - Class in umontreal.iro.lecuyer.simevents
Represents the executive of a discrete-event simulator.
Simulator() - Constructor for class umontreal.iro.lecuyer.simevents.Simulator
Constructs a new simulator using a splay tree for the event list.
Simulator(EventList) - Constructor for class umontreal.iro.lecuyer.simevents.Simulator
Constructs a new simulator using eventList for the event list.
simulator() - Method in class umontreal.iro.lecuyer.simprocs.Bin
Returns the current simulator of this continuous-time variable.
sin - Static variable in class cern.jet.math.Functions
Function that returns Math.sin(a).
sin(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
sin - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
sin - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.sin(a).
sin(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
sin - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
sin - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.sin(a).
sin(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
sin(double, double, double, double, double, double) - Static method in class flanagan.math.Fmath
 
sin(double, double, double) - Static method in class flanagan.math.Fmath
 
sin(double) - Static method in class flanagan.math.Fmath
 
sin() - Method in class jhplot.math.Complex
Sine of this Complex number (doesn't change this Complex number).
sin(ValueErr) - Static method in class jhplot.math.ValueErr
sine of an ValueErr number (trigonometric function)
SIN - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.sin method wrapped as a ComposableFunction.
sin() - Method in class org.apache.commons.math.complex.Complex
Compute the sine of this complex number.
sin(Dfp) - Static method in class org.apache.commons.math.dfp.DfpMath
computes the sine of the argument.
sin(double) - Static method in class org.apache.commons.math.util.FastMath
Sine function.
sinc(double) - Static method in class flanagan.math.Fmath
 
singleRotation(double[][], int, int, double) - Static method in class flanagan.analysis.PCA
 
singular(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
SingularMatrixException - Exception in org.apache.commons.math.linear
Thrown when a matrix is singular.
SingularMatrixException() - Constructor for exception org.apache.commons.math.linear.SingularMatrixException
Construct an exception with a default message.
SingularValueDecomposition - Class in cern.colt.matrix.linalg
For an m x n matrix A with m >= n, the singular value decomposition is an m x n orthogonal matrix U, an n x n diagonal matrix S, and an n x n orthogonal matrix V so that A = U*S*V'.
SingularValueDecomposition(DoubleMatrix2D) - Constructor for class cern.colt.matrix.linalg.SingularValueDecomposition
Constructs and returns a new singular value decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
SingularValueDecomposition - Class in jhplot.math
Singular Value Decomposition.
SingularValueDecomposition(double[][]) - Constructor for class jhplot.math.SingularValueDecomposition
Construct the singular value decomposition
SingularValueDecomposition - Interface in org.apache.commons.math.linear
An interface to classes that implement an algorithm to calculate the Singular Value Decomposition of a real matrix.
SingularValueDecompositionImpl - Class in org.apache.commons.math.linear
Calculates the compact Singular Value Decomposition of a matrix.
SingularValueDecompositionImpl(RealMatrix) - Constructor for class org.apache.commons.math.linear.SingularValueDecompositionImpl
Calculates the compact Singular Value Decomposition of the given matrix.
sinh(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
sinh(double) - Static method in class flanagan.math.Fmath
 
sinh() - Method in class jhplot.math.Complex
Hyperbolic sine of this Complex number (doesn't change this Complex number).
sinh(double) - Static method in class jhplot.math.num.special.Trigonometric
Returns the hyperbolic sine of x.
sinh(ValueErr) - Static method in class jhplot.math.ValueErr
Hyperbolic sine of a value with error
SINH - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.sinh method wrapped as a ComposableFunction.
sinh() - Method in class org.apache.commons.math.complex.Complex
Compute the hyperbolic sine of this complex number.
sinh(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the hyperbolic sine of a number.
sinh(double) - Static method in class org.apache.commons.math.util.MathUtils
Returns the hyperbolic sine of x.
sinPhi() - Method in class hephysics.vec.SpacePoint
sin(phi)
sinTheta() - Method in class hephysics.vec.SpacePoint
sin(theta)
sisnan(float) - Method in class org.netlib.lapack.LAPACK
..
size() - Method in class cern.colt.bitvector.BitMatrix
Returns the size of the receiver which is columns()*rows().
size() - Method in class cern.colt.bitvector.BitVector
Returns the size of the receiver.
size() - Method in class cern.colt.list.AbstractBooleanList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractByteList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractCharList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractCollection
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractDoubleList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractFloatList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractIntList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractLongList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.AbstractShortList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.adapter.DoubleListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.adapter.FloatListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.adapter.IntListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.adapter.LongListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.adapter.ObjectListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.ObjectArrayList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.tbyte.AbstractByteList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.tchar.AbstractCharList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.tdouble.DoubleListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.tfloat.FloatListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.tint.AbstractIntList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.tint.IntListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.tlong.AbstractLongList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.tlong.LongListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.tobject.ObjectArrayList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.list.tobject.ObjectListAdapter
Returns the number of elements in this list.
size() - Method in class cern.colt.list.tshort.AbstractShortList
Returns the number of elements contained in the receiver.
size() - Method in class cern.colt.map.AbstractMap
Returns the number of (key,value) associations currently contained.
size() - Method in class cern.colt.matrix.AbstractMatrix
Returns the number of cells.
size() - Method in class cern.colt.matrix.AbstractMatrix1D
Returns the number of cells.
size() - Method in class cern.colt.matrix.AbstractMatrix2D
Returns the number of cells which is rows()*columns().
size() - Method in class cern.colt.matrix.AbstractMatrix3D
Returns the number of cells which is slices()*rows()*columns().
size() - Method in class cern.colt.matrix.impl.AbstractMatrix
Returns the number of cells.
size() - Method in class cern.colt.matrix.impl.AbstractMatrix1D
Returns the number of cells.
size() - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Returns the number of cells which is rows()*columns().
size() - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Returns the number of cells which is slices()*rows()*columns().
size() - Method in class cern.colt.matrix.io.VectorSize
Returns the size of the vector
size() - Method in class cern.colt.matrix.tbit.BitMatrix
Returns the size of the receiver which is columns()*rows().
size() - Method in class cern.colt.matrix.tbit.BitVector
Returns the size of the receiver.
size() - Method in class cern.hep.aida.bin.AbstractBin
Returns the number of elements contained.
size - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.size().
size() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the number of elements contained in the receiver.
size() - Method in class cern.hep.aida.bin.StaticBin1D
Returns the number of elements contained in the receiver.
size() - Method in class cern.jet.stat.Buffer
Returns the number of elements contained in the receiver.
size() - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Returns the number of elements currently contained in the receiver (identical to the number of values added so far).
size() - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Deprecated. Deprecated. Returns the number of bin boundaries.
size() - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Returns the number of elements contained in the receiver.
size() - Method in class cern.jet.stat.tdouble.quantile.DoubleEquiDepthHistogram
Deprecated. Deprecated. Returns the number of bin boundaries.
size() - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Returns the number of elements currently contained in the receiver (identical to the number of values added so far).
size() - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Returns the number of elements currently contained in the receiver (identical to the number of values added so far).
size() - Method in class cern.jet.stat.tfloat.quantile.FloatEquiDepthHistogram
Deprecated. Deprecated. Returns the number of bin boundaries.
size() - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Returns the number of elements currently contained in the receiver (identical to the number of values added so far).
size() - Method in class hep.aida.ref.Annotation
Get the number of items in the Annotation.
size() - Method in class hep.aida.ref.function.RangeSet
Returns current number of disjoint ranges (non-overlapping intervals)
size() - Method in class hep.aida.ref.histogram.DataPointSet
 
size() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns the number of elements contained.
size - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.size().
size() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the number of elements contained in the receiver.
size() - Method in class hep.aida.tdouble.bin.StaticDoubleBin1D
Returns the number of elements contained in the receiver.
size() - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns the number of elements contained.
size() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the number of elements contained in the receiver.
size - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.size().
size() - Method in class hep.aida.tfloat.bin.StaticFloatBin1D
Returns the number of elements contained in the receiver.
size() - Method in class jhplot.io.EFile
Get the number of events stored in the file.
size() - Method in class jhplot.io.PFile
Get number of objects stored in the file.
size() - Method in class jhplot.math.io.LEDataOutputStream
 
size() - Method in class jhplot.P0D
Return the P10 data length.
size() - Method in class jhplot.P0I
Return the P10 data length.
size() - Method in class jhplot.P1D
Return the length of the data vector.
size() - Method in class jhplot.P2D
Return the length of the data vector.
size() - Method in class jhplot.P3D
Return the length of the data vector.
size() - Method in class jhplot.PND
Data size (number of rows)
size() - Method in class jhplot.PNI
Data size (number of rows)
size() - Method in class jhplot.VHolder
Return the size of the data, i.e.
size() - Method in class org.apache.commons.math.util.OpenIntToDoubleHashMap
Get the number of elements stored in the map.
size() - Method in class org.apache.commons.math.util.OpenIntToFieldHashMap
Get the number of elements stored in the map.
size() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
size() - Method in class umontreal.iro.lecuyer.util.BitVector
Returns the length of the BitVector.
size() - Method in class umontreal.iro.lecuyer.util.TransformingList
 
sizeData() - Method in class jhplot.HPlot
The data size, i.e.
sizeOfRange(double, double) - Method in class cern.hep.aida.bin.QuantileBin1D
Returns how many elements are contained in the range [minElement,maxElement].
sizeOfRange(double, double) - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Returns how many elements are contained in the range [minElement,maxElement].
sizeOfRange(float, float) - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Returns how many elements are contained in the range [minElement,maxElement].
skew() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the skew, which is moment(3,mean()) / standardDeviation()3.
skew(double, double) - Static method in class cern.jet.stat.Descriptive
Returns the skew of a data sequence.
skew(DoubleArrayList, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the skew of a data sequence, which is moment(data,3,mean) / standardDeviation3.
skew(double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the skew of a data sequence.
skew(DoubleArrayList, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the skew of a data sequence, which is moment(data,3,mean) / standardDeviation3.
skew(float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the skew of a data sequence.
skew(FloatArrayList, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the skew of a data sequence, which is moment(data,3,mean) / standardDeviation3.
skew() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the skew, which is moment(3,mean()) / standardDeviation()3.
skew() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the skew, which is moment(3,mean()) / standardDeviation()3.
skew() - Method in class jhplot.P0D
Returns the skew, which is moment(3,mean()) / standardDeviation() Run getStat(0 for evaluation
skew() - Method in class jhplot.P0I
Returns the skew, which is moment(3,mean()) / standardDeviation() Run getStat(0 for evaluation
Skewness - Class in org.apache.commons.math.stat.descriptive.moment
Computes the skewness of the available values.
Skewness() - Constructor for class org.apache.commons.math.stat.descriptive.moment.Skewness
Constructs a Skewness
Skewness(ThirdMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Skewness
Constructs a Skewness with an external moment
Skewness(Skewness) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Skewness
Copy constructor, creates a new Skewness identical to the original
skip(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
skip(int) - Method in class hep.aida.ref.tuple.ChainedTuple
Skips rows.
skip(int) - Method in interface hep.aida.ref.tuple.FTupleCursor
 
skip(int) - Method in class hep.aida.ref.tuple.TupleCursor
 
skipBytes(int) - Method in class jhplot.math.io.LEDataInputStream
 
skipBytes(int) - Method in class jhplot.math.io.LERandomAccessFile
 
skp(HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Useful: for x1*x2+y1*y2+z1*z2
slabad(floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slabrd(int, int, int, float[], int, float[], float[], float[], float[], float[], int, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slacn2(int, float[], float[], int[], floatW, intW, int[]) - Method in class org.netlib.lapack.LAPACK
..
slacon(int, float[], float[], int[], floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
slacpy(String, int, int, float[], int, float[], int) - Method in class org.netlib.lapack.LAPACK
..
sladiv(float, float, float, float, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slae2(float, float, float, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slaebz(int, int, int, int, int, int, float, float, float, float[], float[], float[], int[], float[], float[], intW, int[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slaed0(int, int, int, float[], float[], float[], int, float[], int, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slaed1(int, float[], float[], int, int[], floatW, int, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slaed2(intW, int, int, float[], float[], int, int[], floatW, float[], float[], float[], float[], int[], int[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slaed3(int, int, int, float[], float[], int, float, float[], float[], int[], int[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slaed4(int, int, float[], float[], float[], float, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
slaed5(int, float[], float[], float[], float, floatW) - Method in class org.netlib.lapack.LAPACK
..
slaed6(int, boolean, float, float[], float[], float, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
slaed7(int, int, int, int, int, int, float[], float[], int, int[], floatW, int, float[], int[], int[], int[], int[], int[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slaed8(int, intW, int, int, float[], float[], int, int[], floatW, int, float[], float[], float[], int, float[], int[], intW, int[], float[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slaed9(int, int, int, int, float[], float[], int, float, float[], float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
slaeda(int, int, int, int, int[], int[], int[], int[], float[], float[], int[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slaein(boolean, boolean, int, float[], int, float, float, float[], float[], float[], int, float[], float, float, float, intW) - Method in class org.netlib.lapack.LAPACK
..
slaev2(float, float, float, floatW, floatW, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slaexc(boolean, int, float[], int, float[], int, int, int, int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slag2(float[], int, float[], int, float, floatW, floatW, floatW, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slag2d(int, int, float[], int, double[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
slags2(boolean, float, float, float, float, float, float, floatW, floatW, floatW, floatW, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slagtf(int, float[], float, float[], float[], float, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slagtm(String, int, int, float, float[], float[], float[], float[], int, float, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slagts(int, int, float[], float[], float[], float[], int[], float[], floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
slagv2(float[], int, float[], int, float[], float[], float[], floatW, floatW, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slahqr(boolean, boolean, int, int, int, float[], int, float[], float[], int, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
slahr2(int, int, int, float[], int, float[], float[], int, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slahrd(int, int, int, float[], int, float[], float[], int, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slaic1(int, int, float[], float, float[], float, floatW, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slaisnan(float, float) - Method in class org.netlib.lapack.LAPACK
..
slaln2(boolean, int, int, float, float, float[], int, float, float, float[], int, float, float, float[], int, floatW, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
slals0(int, int, int, int, int, float[], int, float[], int, int[], int, int[], int, float[], int, float[], float[], float[], float[], int, float, float, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slalsa(int, int, int, int, float[], int, float[], int, float[], int, float[], int[], float[], float[], float[], float[], int[], int[], int, int[], float[], float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slalsd(String, int, int, int, float[], float[], float[], int, float, intW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slamc1(intW, intW, booleanW, booleanW) - Method in class org.netlib.lapack.LAPACK
..
slamc2(intW, intW, booleanW, floatW, intW, floatW, intW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slamc3(float, float) - Method in class org.netlib.lapack.LAPACK
..
slamc4(intW, float, int) - Method in class org.netlib.lapack.LAPACK
..
slamc5(int, int, int, boolean, intW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slamch(String) - Method in class org.netlib.lapack.LAPACK
..
slamrg(int, int, float[], int, int, int[]) - Method in class org.netlib.lapack.LAPACK
..
slaneg(int, float[], float[], float, float, int) - Method in class org.netlib.lapack.LAPACK
..
slangb(String, int, int, int, float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slange(String, int, int, float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slangt(String, int, float[], float[], float[]) - Method in class org.netlib.lapack.LAPACK
..
slanhs(String, int, float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slansb(String, String, int, int, float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slansp(String, String, int, float[], float[]) - Method in class org.netlib.lapack.LAPACK
..
slanst(String, int, float[], float[]) - Method in class org.netlib.lapack.LAPACK
..
slansy(String, String, int, float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slantb(String, String, String, int, int, float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slantp(String, String, String, int, float[], float[]) - Method in class org.netlib.lapack.LAPACK
..
slantr(String, String, String, int, int, float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slanv2(floatW, floatW, floatW, floatW, floatW, floatW, floatW, floatW, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slapll(int, float[], int, float[], int, floatW) - Method in class org.netlib.lapack.LAPACK
..
slapmt(boolean, int, int, float[], int, int[]) - Method in class org.netlib.lapack.LAPACK
..
slapy2(float, float) - Method in class org.netlib.lapack.LAPACK
..
slapy3(float, float, float) - Method in class org.netlib.lapack.LAPACK
..
slaqgb(int, int, int, int, float[], int, float[], float[], float, float, float, StringW) - Method in class org.netlib.lapack.LAPACK
..
slaqge(int, int, float[], int, float[], float[], float, float, float, StringW) - Method in class org.netlib.lapack.LAPACK
..
slaqp2(int, int, int, float[], int, int[], float[], float[], float[], float[]) - Method in class org.netlib.lapack.LAPACK
..
slaqps(int, int, int, int, intW, float[], int, int[], float[], float[], float[], float[], float[], int) - Method in class org.netlib.lapack.LAPACK
..
slaqr0(boolean, boolean, int, int, int, float[], int, float[], float[], int, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
slaqr1(int, float[], int, float, float, float, float, float[]) - Method in class org.netlib.lapack.LAPACK
..
slaqr2(boolean, boolean, int, int, int, int, float[], int, int, int, float[], int, intW, intW, float[], float[], float[], int, int, float[], int, int, float[], int, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slaqr3(boolean, boolean, int, int, int, int, float[], int, int, int, float[], int, intW, intW, float[], float[], float[], int, int, float[], int, int, float[], int, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slaqr4(boolean, boolean, int, int, int, float[], int, float[], float[], int, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
slaqr5(boolean, boolean, int, int, int, int, int, float[], float[], float[], int, int, int, float[], int, float[], int, float[], int, int, float[], int, int, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slaqrb(boolean, int, int, int, float[], int, float[], float[], float[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
slaqsb(String, int, int, float[], int, float[], float, float, StringW) - Method in class org.netlib.lapack.LAPACK
..
slaqsp(String, int, float[], float[], float, float, StringW) - Method in class org.netlib.lapack.LAPACK
..
slaqsy(String, int, float[], int, float[], float, float, StringW) - Method in class org.netlib.lapack.LAPACK
..
slaqtr(boolean, boolean, int, float[], int, float[], float, floatW, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slar1v(int, int, int, float, float[], float[], float[], float[], float, float, float[], boolean, intW, floatW, floatW, intW, int[], floatW, floatW, floatW, float[]) - Method in class org.netlib.lapack.LAPACK
..
slar2v(int, float[], float[], float[], int, float[], float[], int) - Method in class org.netlib.lapack.LAPACK
..
slarf(String, int, int, float[], int, float, float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slarfb(String, String, String, String, int, int, int, float[], int, float[], int, float[], int, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slarfg(int, floatW, float[], int, floatW) - Method in class org.netlib.lapack.LAPACK
..
slarft(String, String, int, int, float[], int, float[], float[], int) - Method in class org.netlib.lapack.LAPACK
..
slarfx(String, int, int, float[], float, float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slargv(int, float[], int, float[], int, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slarnv(int, int[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slarra(int, float[], float[], float[], float, float, intW, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slarrb(int, float[], float[], int, int, float, float, int, float[], float[], float[], float[], int[], float, float, int, intW) - Method in class org.netlib.lapack.LAPACK
..
slarrc(String, int, float, float, float[], float[], float, intW, intW, intW, intW) - Method in class org.netlib.lapack.LAPACK
..
slarrd(String, String, int, float, float, int, int, float[], float, float[], float[], float[], float, int, int[], intW, float[], float[], floatW, floatW, int[], int[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slarre(String, int, floatW, floatW, int, int, float[], float[], float[], float, float, float, intW, int[], intW, float[], float[], float[], int[], int[], float[], floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slarrf(int, float[], float[], float[], int, int, float[], float[], float[], float, float, float, float, floatW, float[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slarrj(int, float[], float[], int, int, float, int, float[], float[], float[], int[], float, float, intW) - Method in class org.netlib.lapack.LAPACK
..
slarrk(int, int, float, float, float[], float[], float, float, floatW, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
slarrr(int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slarrv(int, float, float, float[], float[], float, int[], int, int, int, float, floatW, floatW, float[], float[], float[], int[], int[], float[], float[], int, int[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slartg(float, float, floatW, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slartv(int, float[], int, float[], int, float[], float[], int) - Method in class org.netlib.lapack.LAPACK
..
slaruv(int[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slarz(String, int, int, int, float[], int, float, float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slarzb(String, String, String, String, int, int, int, int, float[], int, float[], int, float[], int, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slarzt(String, String, int, int, float[], int, float[], float[], int) - Method in class org.netlib.lapack.LAPACK
..
slas2(float, float, float, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slascl(String, int, int, float, float, int, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
slasd0(int, int, float[], float[], float[], int, float[], int, int, int[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasd1(int, int, int, float[], floatW, floatW, float[], int, float[], int, int[], int[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasd2(int, int, int, intW, float[], float[], float, float, float[], int, float[], int, float[], float[], int, float[], int, int[], int[], int[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasd3(int, int, int, int, float[], float[], int, float[], float[], int, float[], int, float[], int, float[], int, int[], int[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasd4(int, int, float[], float[], float[], float, floatW, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasd5(int, float[], float[], float[], float, floatW, float[]) - Method in class org.netlib.lapack.LAPACK
..
slasd6(int, int, int, int, float[], float[], float[], floatW, floatW, int[], int[], intW, int[], int, float[], int, float[], float[], float[], float[], intW, floatW, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasd7(int, int, int, int, intW, float[], float[], float[], float[], float[], float[], float[], float, float, float[], int[], int[], int[], int[], intW, int[], int, float[], int, floatW, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
slasd8(int, int, float[], float[], float[], float[], float[], float[], int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasda(int, int, int, int, float[], float[], float[], int, float[], int[], float[], float[], float[], float[], int[], int[], int, int[], float[], float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasdq(String, int, int, int, int, int, float[], float[], float[], int, float[], int, float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasdt(int, intW, intW, int[], int[], int[], int) - Method in class org.netlib.lapack.LAPACK
..
slaset(String, int, int, float, float, float[], int) - Method in class org.netlib.lapack.LAPACK
..
slasq1(int, float[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasq2(int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slasq3(int, intW, float[], int, floatW, floatW, floatW, floatW, intW, intW, intW, boolean) - Method in class org.netlib.lapack.LAPACK
..
slasq4(int, int, float[], int, int, float, float, float, float, float, float, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
slasq5(int, int, float[], int, float, floatW, floatW, floatW, floatW, floatW, floatW, boolean) - Method in class org.netlib.lapack.LAPACK
..
slasq6(int, int, float[], int, floatW, floatW, floatW, floatW, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slasr(String, String, String, int, int, float[], float[], float[], int) - Method in class org.netlib.lapack.LAPACK
..
slasrt(String, int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slassq(int, float[], int, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slasv2(float, float, float, floatW, floatW, floatW, floatW, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slaswp(int, float[], int, int, int, int[], int) - Method in class org.netlib.lapack.LAPACK
..
slasy2(boolean, boolean, int, int, int, float[], int, float[], int, float[], int, floatW, float[], int, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
slasyf(String, int, int, intW, float[], int, int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
slatbs(String, String, String, String, int, int, float[], int, float[], floatW, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slatdf(int, int, float[], int, float[], floatW, floatW, int[], int[]) - Method in class org.netlib.lapack.LAPACK
..
slatps(String, String, String, String, int, float[], float[], floatW, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slatrd(String, int, int, float[], int, float[], float[], float[], int) - Method in class org.netlib.lapack.LAPACK
..
slatrs(String, String, String, String, int, float[], int, float[], floatW, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
slatrz(int, int, int, float[], int, float[], float[]) - Method in class org.netlib.lapack.LAPACK
..
slatzm(String, int, int, float[], int, float, float[], float[], int, float[]) - Method in class org.netlib.lapack.LAPACK
..
slauu2(String, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
slauum(String, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
slazq3(int, intW, float[], int, floatW, floatW, floatW, floatW, intW, intW, intW, boolean, intW, floatW, floatW, floatW, floatW, floatW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slazq4(int, int, float[], int, int, float, float, float, float, float, float, floatW, intW, floatW) - Method in class org.netlib.lapack.LAPACK
..
slices() - Method in class cern.colt.matrix.AbstractMatrix3D
Returns the number of slices.
slices() - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Returns the number of slices.
sliceStride() - Method in class cern.colt.matrix.AbstractMatrix3D
Returns the slice stride.
sliceX(String, IHistogram2D, int) - Method in class hep.aida.ref.histogram.HistogramFactory
Slice parallel to the Y axis from a 2D histogram at bin indexY and one bin wide.
sliceX(String, IHistogram2D, int, int) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a slice parallel to the X axis from a 2D histogram, between "indexY1" and "indexY2" (inclusive).
sliceX(int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Slice parallel to the Y axis at bin indexY and one bin wide.
sliceX(int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Create a slice parallel to the axis X axis, between "indexY1" and "indexY2" (inclusive).
sliceX(int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Slice parallel to the Y axis at bin indexY and one bin wide.
sliceX(int, int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Create a slice parallel to the axis X axis, between "indexY1" and "indexY2" (inclusive).
sliceXY(String, IHistogram3D, int, int) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a slice perpendicular to the Z axis from a 3D histogram, between "indexZ1" and "indexZ2" (inclusive).
sliceXY(int) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Create a slice parallel to the XY plane at bin indexZ and one bin wide.
sliceXY(int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Create a slice parallel to the XY plane, between "indexZ1" and "indexZ2" (inclusive).
sliceXY(int) - Method in interface hep.aida.tfloat.FloatIHistogram3D
Create a slice parallel to the XY plane at bin indexZ and one bin wide.
sliceXY(int, int) - Method in interface hep.aida.tfloat.FloatIHistogram3D
Create a slice parallel to the XY plane, between "indexZ1" and "indexZ2" (inclusive).
sliceXZ(String, IHistogram3D, int, int) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a slice perpendicular to the Y axis from a 3D histogram, between "indexY1" and "indexY2" (inclusive).
sliceXZ(int) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Create a slice parallel to the XZ plane at bin indexY and one bin wide.
sliceXZ(int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Create a slice parallel to the XZ plane, between "indexY1" and "indexY2" (inclusive).
sliceXZ(int) - Method in interface hep.aida.tfloat.FloatIHistogram3D
Create a slice parallel to the XZ plane at bin indexY and one bin wide.
sliceXZ(int, int) - Method in interface hep.aida.tfloat.FloatIHistogram3D
Create a slice parallel to the XZ plane, between "indexY1" and "indexY2" (inclusive).
sliceY(String, IHistogram2D, int) - Method in class hep.aida.ref.histogram.HistogramFactory
Slice parallel to the X axis from a 2D histogram at bin indexX and one bin wide.
sliceY(String, IHistogram2D, int, int) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a slice parallel to the Y axis from a 2D histogram, between "indexX1" and "indexX2" (inclusive).
sliceY(int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Slice parallel to the X axis at bin indexX and one bin wide.
sliceY(int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Create a slice parallel to the axis Y axis, between "indexX1" and "indexX2" (inclusive) The returned IHistogram1D represents an instantaneous snapshot of the histogram at the time the slice was created.
sliceY(int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Slice parallel to the X axis at bin indexX and one bin wide.
sliceY(int, int) - Method in interface hep.aida.tfloat.FloatIHistogram2D
Create a slice parallel to the axis Y axis, between "indexX1" and "indexX2" (inclusive) The returned IHistogram1D represents an instantaneous snapshot of the histogram at the time the slice was created.
sliceYZ(String, IHistogram3D, int, int) - Method in class hep.aida.ref.histogram.HistogramFactory
Create a slice perpendicular to the X axis from a 3D histogram, between "indexX1" and "indexX2" (inclusive).
sliceYZ(int) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Create a slice parallel to the YZ plane at bin indexX and one bin wide.
sliceYZ(int, int) - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Create a slice parallel to the YZ plane, between "indexX1" and "indexX2" (inclusive).
sliceYZ(int) - Method in interface hep.aida.tfloat.FloatIHistogram3D
Create a slice parallel to the YZ plane at bin indexX and one bin wide.
sliceYZ(int, int) - Method in interface hep.aida.tfloat.FloatIHistogram3D
Create a slice parallel to the YZ plane, between "indexX1" and "indexX2" (inclusive).
Slicing - Class in jhplot.math
BSD License
Slicing(double[][], int[], String) - Constructor for class jhplot.math.Slicing
Construct a Slice from a matrix and an orthogonal slicing.
Slicing(double[][], double[][]) - Constructor for class jhplot.math.Slicing
Construct a Slice from a matrix and an orthogonal slicing.
Slicing(double[][], double[][], double[][]) - Constructor for class jhplot.math.Slicing
Construct a Slice from a matrix and an orthogonal slicing.
Slicing(double[][], int[][]) - Constructor for class jhplot.math.Slicing
Construct a Slice from a matrix and an orthogonal slicing.
SLine(float, float) - Static method in class jhplot.jadraw.Diagram
A s-line object for scalar particles.
SLoop(float, float) - Static method in class jhplot.jadraw.Diagram
A s-loop for scalar particles.
smax - Variable in class umontreal.iro.lecuyer.gof.GofStat.OutcomeCategoriesChi2
Maximum index for valid expected numbers in the array nbExp.
smin - Variable in class umontreal.iro.lecuyer.gof.GofStat.OutcomeCategoriesChi2
Minimum index for valid expected numbers in the array nbExp.
smooth(double[], double[], double[]) - Method in class org.apache.commons.math.analysis.interpolation.LoessInterpolator
Compute a weighted loess fit on the data at the original abscissae.
smooth(double[], double[]) - Method in class org.apache.commons.math.analysis.interpolation.LoessInterpolator
Compute a loess fit on the data at the original abscissae.
smoothAverage(boolean, int) - Method in class jhplot.stat.Interpolator
Smooth data by averaging over a moving window.
smoothCubicSpline() - Method in class jhplot.stat.Interpolator
Perform a cubic interpolatory spline.
smoothGauss(double) - Method in class jhplot.stat.Interpolator
Computes a Gaussian smoothed version of data.
SmoothingBicubicSplineInterpolator - Class in org.apache.commons.math.analysis.interpolation
Deprecated. This class does not perform smoothing; the name is thus misleading. Please use BicubicSplineInterpolator instead. If smoothing is desired, a tentative implementation is provided in class SmoothingPolynomialBicubicSplineInterpolator. This class will be removed in math 3.0.
SmoothingBicubicSplineInterpolator() - Constructor for class org.apache.commons.math.analysis.interpolation.SmoothingBicubicSplineInterpolator
Deprecated.  
SmoothingCubicSpline - Class in umontreal.iro.lecuyer.functionfit
Represents a cubic spline with nodes at (xi, yi) computed with the smoothing cubic spline algorithm of Schoenberg.
SmoothingCubicSpline(double[], double[], double[], double) - Constructor for class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Constructs a spline with nodes at (xi, yi), with weights wi and smoothing factor ρ = rho.
SmoothingCubicSpline(double[], double[], double) - Constructor for class umontreal.iro.lecuyer.functionfit.SmoothingCubicSpline
Constructs a spline with nodes at (xi, yi), with weights = 1 and smoothing factor ρ = rho.
SmoothingPolynomialBicubicSplineInterpolator - Class in org.apache.commons.math.analysis.interpolation
Generates a bicubic interpolation function.
SmoothingPolynomialBicubicSplineInterpolator() - Constructor for class org.apache.commons.math.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
Default constructor.
SmoothingPolynomialBicubicSplineInterpolator(int) - Constructor for class org.apache.commons.math.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
 
SmoothingPolynomialBicubicSplineInterpolator(int, int) - Constructor for class org.apache.commons.math.analysis.interpolation.SmoothingPolynomialBicubicSplineInterpolator
 
smoothLoess(double, int, double, int) - Method in class jhplot.stat.Interpolator
Performs a Local Regression Algorithm (also Loess, Lowess) for interpolation of data points.
smoothLoess(double, int, double) - Method in class jhplot.stat.Interpolator
Performs a Local Regression Algorithm (also Loess, Lowess) for interpolation of data points.
smoothSpline() - Method in class jhplot.stat.Interpolator
Computes a natural (also known as "free", "unclamped") cubic spline interpolation for the data set.
smout(int, int, int, float[], int, int, String) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
SmpBlas - Class in cern.colt.matrix.linalg
Parallel implementation of the Basic Linear Algebra System for symmetric multi processing boxes.
smpBlas - Static variable in class cern.colt.matrix.linalg.SmpBlas
The public global parallel blas; initialized via SmpBlas.allocateBlas(int, cern.colt.matrix.linalg.Blas).
SmpDoubleBlas - Class in cern.colt.matrix.tdouble.algo
Parallel implementation of the Basic Linear Algebra System for symmetric multi processing boxes.
SmpDoubleBlas() - Constructor for class cern.colt.matrix.tdouble.algo.SmpDoubleBlas
 
SmpFloatBlas - Class in cern.colt.matrix.tfloat.algo
Parallel implementation of the Basic Linear Algebra System for symmetric multi processing boxes.
SmpFloatBlas() - Constructor for class cern.colt.matrix.tfloat.algo.SmpFloatBlas
 
SMScrambleShift - Class in umontreal.iro.lecuyer.hups
This class implements a PointSetRandomization that performs a striped matrix scrambling and adds a random digital shift.
SMScrambleShift() - Constructor for class umontreal.iro.lecuyer.hups.SMScrambleShift
Empty constructor.
SMScrambleShift(RandomStream) - Constructor for class umontreal.iro.lecuyer.hups.SMScrambleShift
Sets internal variable stream to the given stream.
snaitr(intW, String, int, int, int, int, float[], floatW, float[], int, float[], int, int[], float[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
SNAN - Static variable in class org.apache.commons.math.dfp.Dfp
Indicator value for signaling NaN.
snapps(int, intW, int, float[], float[], float[], int, float[], int, float[], float[], int, float[], float[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
snaup2(intW, String, int, String, intW, intW, float, float[], int, int, int, intW, float[], int, float[], int, float[], float[], float[], float[], int, float[], int[], float[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
snaupd(intW, String, int, String, int, floatW, float[], int, float[], int, int[], int[], float[], float[], int, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
snconv(int, float[], float[], float[], float, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
sneigh(float, intW, float[], int, float[], float[], float[], float[], int, float[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
sneupd(boolean, String, boolean[], float[], float[], float[], int, float, float, float[], String, int, String, intW, float, float[], int, float[], int, int[], int[], float[], float[], int, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
sngets(int, String, intW, intW, float[], float[], float[], float[], float[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
snrm2(int, float[], int) - Method in class org.netlib.blas.BLAS
..
SobolSequence - Class in umontreal.iro.lecuyer.hups
This class implements digital nets or digital sequences in base 2 formed by the first n = 2k points of a Sobol' sequence.
SobolSequence(int, int, int) - Constructor for class umontreal.iro.lecuyer.hups.SobolSequence
Constructs a new digital net with n = 2k points and w output digits, in dimension dim, formed by taking the first n points of the Sobol' sequence.
SobolSequence(int, int) - Constructor for class umontreal.iro.lecuyer.hups.SobolSequence
Constructs a Sobol point set with at least n points and 31 output digits, in dimension dim.
SobolSequence(String, int, int, int) - Constructor for class umontreal.iro.lecuyer.hups.SobolSequence
Constructs a new digital net using the direction numbers provided in file filename.
softmax(int, double[]) - Static method in class jhplot.math.ArrayMathUtils
produces a double between 0 and 1 based on the given array x and the index that must be between (0 and x.length) For further information see also: http://www-ccs.ucsd.edu/matlab/toolbox/nnet/softmax.html
solve(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Solves A*X = B.
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.CholeskyDecomposition
Solves A*X = B; returns X.
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.LUDecomposition
Solves A*X = B.
solve(DoubleMatrix1D) - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Solves the system of equations A*X = B (in-place).
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Solves the system of equations A*X = B (in-place).
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.QRDecomposition
Least squares solution of A*X = B; returns X.
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleCholeskyDecomposition
Solves A*X = B(in-place).
solve(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleCholeskyDecomposition
Solves A*x = b(in-place).
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecomposition
Solves A*X = B.
solve(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecomposition
Solves A*x = b.
solve(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Solves the system of equations A*X = B (in-place).
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Solves the system of equations A*X = B (in-place).
solve(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleQRDecomposition
Least squares solution of A*x = b (in-place).
solve(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleQRDecomposition
Least squares solution of A*X = B(in-place).
solve(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleCholeskyDecomposition
Solves A*x = b(in-place).
solve(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleLUDecomposition
Solves A*x = b(in-place).
solve(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleQRDecomposition
Solve a least-squares problem (min ||Ax-b||_2, where A is m-by-n with m >= n) or underdetermined system (Ax=b, where m < n).
solve(DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Solves A*x = b.
solve(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Solves A*X = B.
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleBiCG
 
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleBiCGstab
 
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleCG
 
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleCGLS
 
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleCGS
 
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleChebyshev
 
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleGMRES
 
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleHyBR
 
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleIR
 
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.solver.DoubleIterativeSolver
Solves the given problem, writing result into the vector.
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleMRNSD
 
solve(DoubleMatrix2D, DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.DoubleQMR
 
solve(DoubleMatrix2D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Solves A*x = b.
solve(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatCholeskyDecomposition
Solves A*X = B; returns X.
solve(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatCholeskyDecomposition
 
solve(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecomposition
Solves A*X = B.
solve(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecomposition
Solves A*x = b.
solve(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Solves the system of equations A*X = B (in-place).
solve(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Solves the system of equations A*X = B (in-place).
solve(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatQRDecomposition
Least squares solution of A*x = b; returns x.
solve(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatQRDecomposition
Least squares solution of A*X = B; returns X.
solve(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatCholeskyDecomposition
Solves A*x = b(in-place).
solve(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatLUDecomposition
Solves A*x = b(in-place).
solve(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatQRDecomposition
Solve a least-squares problem (min ||Ax-b||_2, where A is m-by-n with m >= n) or underdetermined system (Ax=b, where m < n).
solve(FloatMatrix2D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Solves A*x = b.
solve(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Solves A*X = B.
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatBiCG
 
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatBiCGstab
 
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatCG
 
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatCGLS
 
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatCGS
 
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatChebyshev
 
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatGMRES
 
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatHyBR
 
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatIR
 
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.solver.FloatIterativeSolver
Solves the given problem, writing result into the vector.
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatMRNSD
 
solve(FloatMatrix2D, FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.FloatQMR
 
solve(FloatMatrix2D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Solves A*x = b.
solve(double[][]) - Method in class jhplot.math.CholeskyDecomposition
Solve A*X = B
solve(double[][], double[][]) - Static method in class jhplot.math.LinearAlgebra
 
solve(double[][]) - Method in class jhplot.math.LUDecomposition
Solve A*X = B
solve(double[][]) - Method in class jhplot.math.QRDecomposition
Least squares solution of A*X = B
solve(double, double, double) - Method in class org.apache.commons.math.analysis.solvers.BisectionSolver
Deprecated. 
solve(double, double) - Method in class org.apache.commons.math.analysis.solvers.BisectionSolver
Deprecated. 
solve(UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.BisectionSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(int, UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.BisectionSolver
Solve for a zero in the given interval, start at startValue.
solve(int, UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.BisectionSolver
Solve for a zero root in the given interval.
solve(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.BisectionSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(double, double) - Method in class org.apache.commons.math.analysis.solvers.BrentSolver
Deprecated. 
solve(double, double, double) - Method in class org.apache.commons.math.analysis.solvers.BrentSolver
Deprecated. 
solve(UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.BrentSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(int, UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.BrentSolver
Find a zero in the given interval with an initial guess.
solve(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.BrentSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(int, UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.BrentSolver
Find a zero in the given interval.
solve(double, double) - Method in class org.apache.commons.math.analysis.solvers.LaguerreSolver
Deprecated. 
solve(double, double, double) - Method in class org.apache.commons.math.analysis.solvers.LaguerreSolver
Deprecated. 
solve(int, UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.LaguerreSolver
Find a real root in the given interval with initial value.
solve(UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.LaguerreSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(int, UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.LaguerreSolver
Find a real root in the given interval.
solve(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.LaguerreSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(Complex[], Complex) - Method in class org.apache.commons.math.analysis.solvers.LaguerreSolver
Deprecated. in 2.2.
solve(double, double) - Method in class org.apache.commons.math.analysis.solvers.MullerSolver
Deprecated. 
solve(double, double, double) - Method in class org.apache.commons.math.analysis.solvers.MullerSolver
Deprecated. 
solve(int, UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.MullerSolver
Find a real root in the given interval with initial value.
solve(UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.MullerSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(int, UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.MullerSolver
Find a real root in the given interval.
solve(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.MullerSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(double, double) - Method in class org.apache.commons.math.analysis.solvers.NewtonSolver
Deprecated. 
solve(double, double, double) - Method in class org.apache.commons.math.analysis.solvers.NewtonSolver
Deprecated. 
solve(int, UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.NewtonSolver
Find a zero near the midpoint of min and max.
solve(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.NewtonSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(int, UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.NewtonSolver
Find a zero near the value startValue.
solve(UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.NewtonSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(double, double) - Method in class org.apache.commons.math.analysis.solvers.RiddersSolver
Deprecated. 
solve(double, double, double) - Method in class org.apache.commons.math.analysis.solvers.RiddersSolver
Deprecated. 
solve(int, UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.RiddersSolver
Find a root in the given interval with initial value.
solve(UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.RiddersSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(int, UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.RiddersSolver
Find a root in the given interval.
solve(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.RiddersSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(double, double) - Method in class org.apache.commons.math.analysis.solvers.SecantSolver
Deprecated. 
solve(double, double, double) - Method in class org.apache.commons.math.analysis.solvers.SecantSolver
Deprecated. 
solve(int, UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.SecantSolver
Find a zero in the given interval.
solve(UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.SecantSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(int, UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.SecantSolver
Find a zero in the given interval.
solve(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.SecantSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(double, double) - Method in interface org.apache.commons.math.analysis.solvers.UnivariateRealSolver
Deprecated. replaced by UnivariateRealSolver.solve(UnivariateRealFunction, double, double) since 2.0
solve(UnivariateRealFunction, double, double) - Method in interface org.apache.commons.math.analysis.solvers.UnivariateRealSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(double, double, double) - Method in interface org.apache.commons.math.analysis.solvers.UnivariateRealSolver
Deprecated. replaced by UnivariateRealSolver.solve(UnivariateRealFunction, double, double, double) since 2.0
solve(UnivariateRealFunction, double, double, double) - Method in interface org.apache.commons.math.analysis.solvers.UnivariateRealSolver
Deprecated. in 2.2 (to be removed in 3.0).
solve(int, UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverImpl
Deprecated. Solve for a zero root in the given interval.
solve(int, UnivariateRealFunction, double, double, double) - Method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverImpl
Deprecated. Solve for a zero in the given interval, start at startValue.
solve(UnivariateRealFunction, double, double) - Static method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverUtils
Convenience method to find a zero of a univariate real function.
solve(UnivariateRealFunction, double, double, double) - Static method in class org.apache.commons.math.analysis.solvers.UnivariateRealSolverUtils
Convenience method to find a zero of a univariate real function.
solve(double[]) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Deprecated. 
solve(RealMatrix) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Deprecated. 
solve(BigDecimal[]) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the solution vector for a linear system with coefficient matrix = this and constant vector = b.
solve(BigMatrix) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve(BigDecimal[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve(double[]) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve(BigMatrix) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns a matrix of (column) solution vectors for linear systems with coefficient matrix = this and constant vectors = columns of b.
solve(double[]) - Method in interface org.apache.commons.math.linear.DecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(RealVector) - Method in interface org.apache.commons.math.linear.DecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(RealMatrix) - Method in interface org.apache.commons.math.linear.DecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(T[]) - Method in interface org.apache.commons.math.linear.FieldDecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldDecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(FieldMatrix<T>) - Method in interface org.apache.commons.math.linear.FieldDecompositionSolver
Solve the linear equation A × X = B for matrices A.
solve(double[]) - Method in interface org.apache.commons.math.linear.RealMatrix
Deprecated. as of release 2.0, replaced by DecompositionSolver.solve(double[])
solve(RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Deprecated. as of release 2.0, replaced by DecompositionSolver.solve(RealMatrix)
solve2(double, double) - Method in class org.apache.commons.math.analysis.solvers.MullerSolver
Deprecated. replaced by MullerSolver.solve2(UnivariateRealFunction, double, double) since 2.0
solve2(UnivariateRealFunction, double, double) - Method in class org.apache.commons.math.analysis.solvers.MullerSolver
Deprecated. in 2.2 (to be removed in 3.0).
solveAll(double[], double) - Method in class org.apache.commons.math.analysis.solvers.LaguerreSolver
Deprecated. in 2.2.
solveAll(Complex[], Complex) - Method in class org.apache.commons.math.analysis.solvers.LaguerreSolver
Deprecated. in 2.2.
solveCubic(double, double, double, double) - Static method in class jhplot.math.Numeric
Calculates the roots of the cubic equation, a must be different from 0 (or use quadratic equation solver).
solveLinear(double, double) - Static method in class jhplot.math.Numeric
Calculates the roots of the linear equation, a must be different from 0.
solveLinearSet(double[]) - Method in class flanagan.math.Matrix
 
solveQuadratic(double, double, double) - Static method in class jhplot.math.Numeric
Calculates the roots of the quadratic equation, a must be different from 0 (or use linear equation solver).
solveQuartic(double, double, double, double, double) - Static method in class jhplot.math.Numeric
Calculates the roots of the quartics equation, a must be different from 0 (or use cubic equation solver).
solveTranspose(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Solves X*A = B, which is also A'*X' = B'.
solveTranspose(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Solves X*A = B, which is also A'*X' = B'.
solveTranspose(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Solves X*A = B, which is also A'*X' = B'.
solveTranspose(double[][], double[][]) - Static method in class jhplot.math.LinearAlgebra
 
sopgtr(String, int, float[], float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sopmtr(String, String, String, int, int, float[], float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sorg2l(int, int, int, float[], int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sorg2r(int, int, int, float[], int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sorgbr(String, int, int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sorghr(int, int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sorgl2(int, int, int, float[], int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sorglq(int, int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sorgql(int, int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sorgqr(int, int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sorgr2(int, int, int, float[], int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sorgrq(int, int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sorgtr(String, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sorm2l(String, String, int, int, int, float[], int, float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sorm2r(String, String, int, int, int, float[], int, float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sormbr(String, String, String, int, int, int, float[], int, float[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sormhr(String, String, int, int, int, int, float[], int, float[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sorml2(String, String, int, int, int, float[], int, float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sormlq(String, String, int, int, int, float[], int, float[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sormql(String, String, int, int, int, float[], int, float[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sormqr(String, String, int, int, int, float[], int, float[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sormr2(String, String, int, int, int, float[], int, float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sormr3(String, String, int, int, int, int, float[], int, float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sormrq(String, String, int, int, int, float[], int, float[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sormrz(String, String, int, int, int, int, float[], int, float[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sormtr(String, String, String, int, int, float[], int, float[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sort() - Method in class cern.colt.list.AbstractList
Sorts the receiver into ascending order.
sort(DoubleMatrix1D) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the vector into ascending order, according to the natural ordering.
sort(DoubleMatrix1D, DoubleComparator) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the vector into ascending order, according to the order induced by the specified comparator.
sort(DoubleMatrix2D, double[]) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the virtual column aggregates; Particularly efficient when comparing expensive aggregates, because aggregates need not be recomputed time and again, as is the case for comparator based sorts.
sort(DoubleMatrix2D, int) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
sort(DoubleMatrix2D, DoubleMatrix1DComparator) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix rows according to the order induced by the specified comparator.
sort(DoubleMatrix2D, BinFunction1D) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix rows into ascending order, according to the natural ordering of the values computed by applying the given aggregation function to each row; Particularly efficient when comparing expensive aggregates, because aggregates need not be recomputed time and again, as is the case for comparator based sorts.
sort(DoubleMatrix3D, int, int) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
sort(DoubleMatrix3D, DoubleMatrix2DComparator) - Method in class cern.colt.matrix.doublealgo.Sorting
Sorts the matrix slices according to the order induced by the specified comparator.
sort(ObjectMatrix1D) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the vector into ascending order, according to the natural ordering.
sort(ObjectMatrix1D, Comparator) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the vector into ascending order, according to the order induced by the specified comparator.
sort(ObjectMatrix2D, int) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
sort(ObjectMatrix2D, ObjectMatrix1DComparator) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the matrix rows according to the order induced by the specified comparator.
sort(ObjectMatrix3D, int, int) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
sort(ObjectMatrix3D, ObjectMatrix2DComparator) - Method in class cern.colt.matrix.objectalgo.Sorting
Sorts the matrix slices according to the order induced by the specified comparator.
sort(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Sorts the vector into ascending order, according to the natural ordering.
sort(DoubleMatrix1D, DoubleComparator) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Sorts the vector into ascending order, according to the order induced by the specified comparator.
sort(DoubleMatrix2D, double[]) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the virtual column aggregates; Particularly efficient when comparing expensive aggregates, because aggregates need not be recomputed time and again, as is the case for comparator based sorts.
sort(DoubleMatrix2D, int) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
sort(DoubleMatrix2D, DoubleMatrix1DComparator) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Sorts the matrix rows according to the order induced by the specified comparator.
sort(DoubleMatrix2D, DoubleBinFunction1D) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the values computed by applying the given aggregation function to each row; Particularly efficient when comparing expensive aggregates, because aggregates need not be recomputed time and again, as is the case for comparator based sorts.
sort(DoubleMatrix3D, int, int) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
sort(DoubleMatrix3D, DoubleMatrix2DComparator) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Sorts the matrix slices according to the order induced by the specified comparator.
sort(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Sorts the vector into ascending order, according to the natural ordering.
sort(FloatMatrix1D, FloatComparator) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Sorts the vector into ascending order, according to the order induced by the specified comparator.
sort(FloatMatrix2D, float[]) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the virtual column aggregates; Particularly efficient when comparing expensive aggregates, because aggregates need not be recomputed time and again, as is the case for comparator based sorts.
sort(FloatMatrix2D, int) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
sort(FloatMatrix2D, FloatMatrix1DComparator) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Sorts the matrix rows according to the order induced by the specified comparator.
sort(FloatMatrix2D, FloatBinFunction1D) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the values computed by applying the given aggregation function to each row; Particularly efficient when comparing expensive aggregates, because aggregates need not be recomputed time and again, as is the case for comparator based sorts.
sort(FloatMatrix3D, int, int) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
sort(FloatMatrix3D, FloatMatrix2DComparator) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Sorts the matrix slices according to the order induced by the specified comparator.
sort(IntMatrix1D) - Method in class cern.colt.matrix.tint.algo.IntSorting
Sorts the vector into ascending order, according to the natural ordering.
sort(IntMatrix1D, IntComparator) - Method in class cern.colt.matrix.tint.algo.IntSorting
Sorts the vector into ascending order, according to the order induced by the specified comparator.
sort(IntMatrix2D, int[]) - Method in class cern.colt.matrix.tint.algo.IntSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the virtual column aggregates; Particularly efficient when comparing expensive aggregates, because aggregates need not be recomputed time and again, as is the case for comparator based sorts.
sort(IntMatrix2D, int) - Method in class cern.colt.matrix.tint.algo.IntSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
sort(IntMatrix2D, IntMatrix1DComparator) - Method in class cern.colt.matrix.tint.algo.IntSorting
Sorts the matrix rows according to the order induced by the specified comparator.
sort(IntMatrix3D, int, int) - Method in class cern.colt.matrix.tint.algo.IntSorting
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
sort(IntMatrix3D, IntMatrix2DComparator) - Method in class cern.colt.matrix.tint.algo.IntSorting
Sorts the matrix slices according to the order induced by the specified comparator.
sort(LongMatrix1D) - Method in class cern.colt.matrix.tlong.algo.LongSorting
Sorts the vector into ascending order, according to the natural ordering.
sort(LongMatrix1D, LongComparator) - Method in class cern.colt.matrix.tlong.algo.LongSorting
Sorts the vector into ascending order, according to the order induced by the specified comparator.
sort(LongMatrix2D, long[]) - Method in class cern.colt.matrix.tlong.algo.LongSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the virtual column aggregates; Particularly efficient when comparing expensive aggregates, because aggregates need not be recomputed time and again, as is the case for comparator based sorts.
sort(LongMatrix2D, int) - Method in class cern.colt.matrix.tlong.algo.LongSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
sort(LongMatrix2D, LongMatrix1DComparator) - Method in class cern.colt.matrix.tlong.algo.LongSorting
Sorts the matrix rows according to the order induced by the specified comparator.
sort(LongMatrix3D, int, int) - Method in class cern.colt.matrix.tlong.algo.LongSorting
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
sort(LongMatrix3D, LongMatrix2DComparator) - Method in class cern.colt.matrix.tlong.algo.LongSorting
Sorts the matrix slices according to the order induced by the specified comparator.
sort(ObjectMatrix1D) - Method in class cern.colt.matrix.tobject.algo.ObjectSorting
Sorts the vector into ascending order, according to the natural ordering.
sort(ObjectMatrix1D, Comparator) - Method in class cern.colt.matrix.tobject.algo.ObjectSorting
Sorts the vector into ascending order, according to the order induced by the specified comparator.
sort(ObjectMatrix2D, int) - Method in class cern.colt.matrix.tobject.algo.ObjectSorting
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
sort(ObjectMatrix2D, ObjectMatrix1DComparator) - Method in class cern.colt.matrix.tobject.algo.ObjectSorting
Sorts the matrix rows according to the order induced by the specified comparator.
sort(ObjectMatrix3D, int, int) - Method in class cern.colt.matrix.tobject.algo.ObjectSorting
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
sort(ObjectMatrix3D, ObjectMatrix2DComparator) - Method in class cern.colt.matrix.tobject.algo.ObjectSorting
Sorts the matrix slices according to the order induced by the specified comparator.
sort() - Method in class cern.jet.stat.Buffer
Sorts the receiver.
sort() - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Sorts the receiver.
sort() - Method in class flanagan.analysis.Stat
 
sort(int[]) - Method in class flanagan.analysis.Stat
 
sort() - Method in class flanagan.math.ArrayMaths
 
sort(int[]) - Method in class flanagan.math.ArrayMaths
 
sort(double[]) - Static method in class jhplot.math.DoubleArray
Sorts an array in ascending order.
sort(double[][], int) - Static method in class jhplot.math.DoubleArray
Sorts the rows of a matrix using a specified column as the key.
sort(int[], Object[], Comparator, boolean) - Static method in class jhplot.math.SortUtils
Do a sort on indices.
sort(Object[], Comparator, boolean) - Static method in class jhplot.math.SortUtils
Do a sort on indices.
sort(Object[], Comparator) - Static method in class jhplot.math.SortUtils
Do an unstable sort.
sort(int[], Object[], Comparator) - Static method in class jhplot.math.SortUtils
Do an unstable sort.
sort() - Method in class jhplot.P0D
Sort into ascending order
sort() - Method in class jhplot.P0I
Sort into ascending order
sortColumnIndexes() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Sorts column indexes
sortColumnIndexes() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Sorts column indexes
sortColumnIndexes() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Sorts column indexes
sortColumnIndexes() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Sorts column indexes
sortColumnIndexes() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Sorts column indexes
sortedElements() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns a copy of the currently stored elements, sorted ascending.
sortedElements() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns a copy of the currently stored elements, sorted ascending.
sortedElements() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns a copy of the currently stored elements, sorted ascending.
sortedOriginalData() - Method in class flanagan.analysis.BoxCox
 
sortFromTo(int, int) - Method in class cern.colt.list.AbstractList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.BooleanArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.ByteArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.CharArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.IntArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.LongArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.ShortArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.tboolean.BooleanArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.tbyte.ByteArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.tchar.CharArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.tint.IntArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.tlong.LongArrayList
Sorts the specified range of the receiver into ascending order.
sortFromTo(int, int) - Method in class cern.colt.list.tshort.ShortArrayList
Sorts the specified range of the receiver into ascending order.
sortIndex(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Sorts indexes of the vector into ascending order.
sortIndex(DoubleMatrix1D, IntComparator) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Multithreaded method that sorts indexes of the vector according to the comparator comp.
sortIndex(DoubleMatrix1D, DoubleComparator) - Method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Sorts indexes of the vector according to the comparator c.
sortIndex(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Sorts indexes of the vector into ascending order.
sortIndex(FloatMatrix1D, IntComparator) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Multithreaded method that sorts indexes of the vector according to the comparator comp.
sortIndex(FloatMatrix1D, FloatComparator) - Method in class cern.colt.matrix.tfloat.algo.FloatSorting
Sorts indexes of the vector according to the comparator c.
sortIndex(IntMatrix1D) - Method in class cern.colt.matrix.tint.algo.IntSorting
Sorts indexes of the vector into ascending order.
sortIndex(IntMatrix1D, IntComparator) - Method in class cern.colt.matrix.tint.algo.IntSorting
Sorts indexes of the vector according to the comparator c.
sortIndex(LongMatrix1D) - Method in class cern.colt.matrix.tlong.algo.LongSorting
Sorts indexes of the vector into ascending order.
sortIndex(LongMatrix1D, LongComparator) - Method in class cern.colt.matrix.tlong.algo.LongSorting
Sorts indexes of the vector according to the comparator c.
sortIndex() - Method in class jhplot.P0D
Return indexes of sorted array in increasing order.
sortIndex() - Method in class jhplot.P0I
Return indexes of sorted array in increasing order.
Sorting - Class in cern.colt.matrix.doublealgo
Matrix quicksorts and mergesorts.
Sorting - Class in cern.colt.matrix.objectalgo
Matrix quicksorts and mergesorts.
Sorting - Class in cern.colt
Quicksorts, mergesorts and binary searches; complements java.util.Arrays.
Sorting - Class in jhplot.math
Quick Sort algoritm.
Sorting(double[], boolean) - Constructor for class jhplot.math.Sorting
Construct an ascending order.
sortMaxToMin(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a sorted array from the maximum to the minimum value.
sortMaxToMin(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a sorted array from the maximum to the minimum value.
sortMinToMax(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a sorted array from the minimum to the maximum value.
sortMinToMax(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a sorted array from the minimum to the maximum value.
sortRowIndexes() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Sorts row indexes
sortRowIndexes() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Sorts row indexes
sortRowIndexes() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Sorts row indexes
sortRowIndexes() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Sorts row indexes
sortRowIndexes() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Sorts row indexes
sortRowIndexes() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Sorts row indexes
sortRowIndexes() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Sorts row indexes
SortUtils - Class in jhplot.math
Utility class providing some useful static sort methods.
SortUtils() - Constructor for class jhplot.math.SortUtils
 
SpacePoint - Class in hephysics.vec
A Hep3Vector representing a point in space.
SpacePoint() - Constructor for class hephysics.vec.SpacePoint
Default constructor.
SpacePoint(SpacePoint) - Constructor for class hephysics.vec.SpacePoint
Copy constructor
SpacePoint(Hep3Vector) - Constructor for class hephysics.vec.SpacePoint
 
SpacePoint.Representation - Enum in hephysics.vec
 
sparse - Static variable in class cern.colt.matrix.DoubleFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.DoubleFactory2D
A factory producing sparse hash matrices.
sparse - Static variable in class cern.colt.matrix.DoubleFactory3D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.ObjectFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.ObjectFactory2D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.ObjectFactory3D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tdcomplex.DComplexFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tdcomplex.DComplexFactory2D
A factory producing sparse hash matrices.
sparse - Static variable in class cern.colt.matrix.tdcomplex.DComplexFactory3D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tdouble.DoubleFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tdouble.DoubleFactory2D
A factory producing sparse hash matrices.
sparse - Static variable in class cern.colt.matrix.tdouble.DoubleFactory3D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tfcomplex.FComplexFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tfcomplex.FComplexFactory2D
A factory producing sparse hash matrices.
sparse - Static variable in class cern.colt.matrix.tfcomplex.FComplexFactory3D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tfloat.FloatFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tfloat.FloatFactory2D
A factory producing sparse hash matrices.
sparse - Static variable in class cern.colt.matrix.tfloat.FloatFactory3D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tint.IntFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tint.IntFactory2D
A factory producing sparse hash matrices.
sparse - Static variable in class cern.colt.matrix.tint.IntFactory3D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tlong.LongFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tlong.LongFactory2D
A factory producing sparse hash matrices.
sparse - Static variable in class cern.colt.matrix.tlong.LongFactory3D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tobject.ObjectFactory1D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tobject.ObjectFactory2D
A factory producing sparse matrices.
sparse - Static variable in class cern.colt.matrix.tobject.ObjectFactory3D
A factory producing sparse matrices.
SparseCCDComplexMatrix2D - Class in cern.colt.matrix.tdcomplex.impl
Sparse column-compressed 2-d matrix holding complex elements.
SparseCCDComplexMatrix2D(double[][]) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Constructs a matrix with a copy of the given values.
SparseCCDComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCDComplexMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCDComplexMatrix2D(int, int, int[], int[], double, double, boolean) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Constructs a matrix with indexes given in the coordinate format and a single value.
SparseCCDComplexMatrix2D(int, int, int[], int[], double[], boolean, boolean) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseCCDoubleMatrix2D - Class in cern.colt.matrix.tdouble.impl
Sparse column-compressed 2-d matrix holding double elements.
SparseCCDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Constructs a matrix with a copy of the given values.
SparseCCDoubleMatrix2D(Dcs_common.Dcs) - Constructor for class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Constructs a matrix with a given internal storage.
SparseCCDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCDoubleMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCDoubleMatrix2D(int, int, int[], int[], double, boolean, boolean) - Constructor for class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Constructs a matrix with indexes given in the coordinate format and a single value.
SparseCCDoubleMatrix2D(int, int, int[], int[], double[], boolean, boolean, boolean) - Constructor for class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseCCFComplexMatrix2D - Class in cern.colt.matrix.tfcomplex.impl
Sparse column-compressed 2-d matrix holding complex elements.
SparseCCFComplexMatrix2D(float[][]) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Constructs a matrix with a copy of the given values.
SparseCCFComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCFComplexMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCFComplexMatrix2D(int, int, int[], int[], float, float, boolean) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Constructs a matrix with indexes given in the coordinate format and a single value.
SparseCCFComplexMatrix2D(int, int, int[], int[], float[], boolean, boolean) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseCCFloatMatrix2D - Class in cern.colt.matrix.tfloat.impl
Sparse column-compressed 2-d matrix holding float elements.
SparseCCFloatMatrix2D(float[][]) - Constructor for class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Constructs a matrix with a copy of the given values.
SparseCCFloatMatrix2D(Scs_common.Scs) - Constructor for class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Constructs a matrix with a given internal storage.
SparseCCFloatMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCFloatMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCFloatMatrix2D(int, int, int[], int[], float, boolean, boolean) - Constructor for class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Constructs a matrix with indexes given in the coordinate format and a single value.
SparseCCFloatMatrix2D(int, int, int[], int[], float[], boolean, boolean, boolean) - Constructor for class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseCCIntMatrix2D - Class in cern.colt.matrix.tint.impl
Sparse column-compressed 2-d matrix holding int elements.
SparseCCIntMatrix2D(int[][]) - Constructor for class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Constructs a matrix with a copy of the given values.
SparseCCIntMatrix2D(int, int) - Constructor for class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCIntMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCIntMatrix2D(int, int, int[], int[], int, boolean, boolean) - Constructor for class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Constructs a matrix with indexes given in the coordinate format and a single value.
SparseCCIntMatrix2D(int, int, int[], int[], int[], boolean, boolean, boolean) - Constructor for class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseCCLongMatrix2D - Class in cern.colt.matrix.tlong.impl
Sparse column-compressed 2-d matrix holding long elements.
SparseCCLongMatrix2D(long[][]) - Constructor for class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Constructs a matrix with a copy of the given values.
SparseCCLongMatrix2D(int, int) - Constructor for class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCLongMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCLongMatrix2D(int, int, int[], int[], long, boolean, boolean) - Constructor for class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Constructs a matrix with indexes given in the coordinate format and a single value.
SparseCCLongMatrix2D(int, int, int[], int[], long[], boolean, boolean, boolean) - Constructor for class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseCCMDComplexMatrix2D - Class in cern.colt.matrix.tdcomplex.impl
Sparse column-compressed-modified 2-d matrix holding complex elements.
SparseCCMDComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseCCMDComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCMDoubleMatrix2D - Class in cern.colt.matrix.tdouble.impl
Sparse column-compressed-modified 2-d matrix holding double elements.
SparseCCMDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdouble.impl.SparseCCMDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCMFComplexMatrix2D - Class in cern.colt.matrix.tfcomplex.impl
Sparse column-compressed-modified 2-d matrix holding complex elements.
SparseCCMFComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseCCMFComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCMFloatMatrix2D - Class in cern.colt.matrix.tfloat.impl
Sparse column-compressed-modified 2-d matrix holding float elements.
SparseCCMFloatMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfloat.impl.SparseCCMFloatMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCMIntMatrix2D - Class in cern.colt.matrix.tint.impl
Sparse column-compressed-modified 2-d matrix holding int elements.
SparseCCMIntMatrix2D(int, int) - Constructor for class cern.colt.matrix.tint.impl.SparseCCMIntMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCMLongMatrix2D - Class in cern.colt.matrix.tlong.impl
Sparse column-compressed-modified 2-d matrix holding long elements.
SparseCCMLongMatrix2D(int, int) - Constructor for class cern.colt.matrix.tlong.impl.SparseCCMLongMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCMObjectMatrix2D - Class in cern.colt.matrix.tobject.impl
Sparse column-compressed-modified 2-d matrix holding Object elements.
SparseCCMObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.tobject.impl.SparseCCMObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCObjectMatrix2D - Class in cern.colt.matrix.tobject.impl
Sparse column-compressed 2-d matrix holding Object elements.
SparseCCObjectMatrix2D(Object[][]) - Constructor for class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Constructs a matrix with a copy of the given values.
SparseCCObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCObjectMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseCCObjectMatrix2D(int, int, int[], int[], Object, boolean) - Constructor for class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Constructs a matrix with indexes given in the coordinate format and a single value.
SparseCCObjectMatrix2D(int, int, int[], int[], Object[], boolean, boolean) - Constructor for class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseDComplexMatrix1D - Class in cern.colt.matrix.tdcomplex.impl
Sparse hashed 1-d matrix (aka vector) holding complex elements.
SparseDComplexMatrix1D(double[]) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
Constructs a matrix with a copy of the given values.
SparseDComplexMatrix1D(int) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix1D
Constructs a matrix with a given number of cells.
SparseDComplexMatrix2D - Class in cern.colt.matrix.tdcomplex.impl
Sparse hashed 2-d matrix holding complex elements.
SparseDComplexMatrix2D(double[][]) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
Constructs a matrix with a copy of the given values.
SparseDComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseDComplexMatrix3D - Class in cern.colt.matrix.tdcomplex.impl
Sparse hashed 3-d matrix holding complex elements.
SparseDComplexMatrix3D(double[][][]) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
Constructs a matrix with a copy of the given values.
SparseDComplexMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseDoubleAlgebra - Class in cern.colt.matrix.tdouble.algo
Linear algebraic matrix operations operating on sparse matrices.
SparseDoubleAlgebra() - Constructor for class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Constructs a new instance with an equality tolerance given by Property.DEFAULT.tolerance().
SparseDoubleAlgebra(double) - Constructor for class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
Constructs a new instance with the given equality tolerance.
SparseDoubleCholeskyDecomposition - Class in cern.colt.matrix.tdouble.algo.decomposition
For a symmetric, positive definite matrix A, the Cholesky decomposition is a lower triangular matrix L so that A = L*L'; If the matrix is not symmetric positive definite, the IllegalArgumentException is thrown.
SparseDoubleCholeskyDecomposition(DoubleMatrix2D, int) - Constructor for class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleCholeskyDecomposition
Constructs and returns a new Cholesky decomposition object for a sparse symmetric and positive definite matrix; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
SparseDoubleLUDecomposition - Class in cern.colt.matrix.tdouble.algo.decomposition
For a square matrix A, the LU decomposition is an unit lower triangular matrix L, an upper triangular matrix U, and a permutation vector piv so that A(piv,:) = L*U
SparseDoubleLUDecomposition(DoubleMatrix2D, int, boolean) - Constructor for class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleLUDecomposition
Constructs and returns a new LU Decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
SparseDoubleMatrix1D - Class in cern.colt.matrix.impl
Sparse hashed 1-d matrix (aka vector) holding double elements.
SparseDoubleMatrix1D(double[]) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix1D
Constructs a matrix with a copy of the given values.
SparseDoubleMatrix1D(int) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix1D
Constructs a matrix with a given number of cells.
SparseDoubleMatrix1D(int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix1D
Constructs a matrix with a given number of parameters.
SparseDoubleMatrix1D - Class in cern.colt.matrix.tdouble.impl
Sparse hashed 1-d matrix (aka vector) holding double elements.
SparseDoubleMatrix1D(double[]) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Constructs a matrix with a copy of the given values.
SparseDoubleMatrix1D(int) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Constructs a matrix with a given number of cells.
SparseDoubleMatrix1D(int, int, double, double) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
Constructs a matrix with a given number of parameters.
SparseDoubleMatrix2D - Class in cern.colt.matrix.impl
Sparse hashed 2-d matrix holding double elements.
SparseDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix2D
Constructs a matrix with a copy of the given values.
SparseDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseDoubleMatrix2D(int, int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix2D
Constructs a matrix with a given number of rows and columns using memory as specified.
SparseDoubleMatrix2D - Class in cern.colt.matrix.tdouble.impl
Sparse hashed 2-d matrix holding double elements.
SparseDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Constructs a matrix with a copy of the given values.
SparseDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseDoubleMatrix2D(int, int, int, double, double) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Constructs a matrix with a given number of rows and columns using memory as specified.
SparseDoubleMatrix2D(int, int, int[], int[], double) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Constructs a matrix with a copy of the given indexes and a single value.
SparseDoubleMatrix2D(int, int, int[], int[], double[]) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Constructs a matrix with a copy of the given indexes and values.
SparseDoubleMatrix2D(MatrixVectorReader) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
Constructs a matrix from MatrixVectorReader.
SparseDoubleMatrix3D - Class in cern.colt.matrix.impl
Sparse hashed 3-d matrix holding double elements.
SparseDoubleMatrix3D(double[][][]) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix3D
Constructs a matrix with a copy of the given values.
SparseDoubleMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseDoubleMatrix3D(int, int, int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseDoubleMatrix3D
Constructs a matrix with a given number of slices, rows and columns using memory as specified.
SparseDoubleMatrix3D - Class in cern.colt.matrix.tdouble.impl
Sparse hashed 3-d matrix holding double elements.
SparseDoubleMatrix3D(double[][][]) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
Constructs a matrix with a copy of the given values.
SparseDoubleMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseDoubleMatrix3D(int, int, int, int, double, double) - Constructor for class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
Constructs a matrix with a given number of slices, rows and columns using memory as specified.
SparseDoubleQRDecomposition - Class in cern.colt.matrix.tdouble.algo.decomposition
For an m x n matrix A with m >= n, the QR decomposition is an m x n orthogonal matrix Q and an n x n upper triangular matrix R so that A = Q*R.
SparseDoubleQRDecomposition(DoubleMatrix2D, int) - Constructor for class cern.colt.matrix.tdouble.algo.decomposition.SparseDoubleQRDecomposition
Constructs and returns a new QR decomposition object; computed by Householder reflections; If m < n then then the QR of A' is computed.
SparseFComplexMatrix1D - Class in cern.colt.matrix.tfcomplex.impl
Sparse hashed 1-d matrix (aka vector) holding complex elements.
SparseFComplexMatrix1D(float[]) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
Constructs a matrix with a copy of the given values.
SparseFComplexMatrix1D(int) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix1D
Constructs a matrix with a given number of cells.
SparseFComplexMatrix2D - Class in cern.colt.matrix.tfcomplex.impl
Sparse hashed 2-d matrix holding complex elements.
SparseFComplexMatrix2D(float[][]) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
Constructs a matrix with a copy of the given values.
SparseFComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseFComplexMatrix3D - Class in cern.colt.matrix.tfcomplex.impl
Sparse hashed 3-d matrix holding complex elements.
SparseFComplexMatrix3D(float[][][]) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
Constructs a matrix with a copy of the given values.
SparseFComplexMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseFieldMatrix<T extends FieldElement<T>> - Class in org.apache.commons.math.linear
Sparse matrix implementation based on an open addressed map.
SparseFieldMatrix(Field<T>) - Constructor for class org.apache.commons.math.linear.SparseFieldMatrix
Creates a matrix with no data.
SparseFieldMatrix(Field<T>, int, int) - Constructor for class org.apache.commons.math.linear.SparseFieldMatrix
Create a new SparseFieldMatrix with the supplied row and column dimensions.
SparseFieldMatrix(SparseFieldMatrix<T>) - Constructor for class org.apache.commons.math.linear.SparseFieldMatrix
Copy constructor.
SparseFieldMatrix(FieldMatrix<T>) - Constructor for class org.apache.commons.math.linear.SparseFieldMatrix
Generic copy constructor.
SparseFieldVector<T extends FieldElement<T>> - Class in org.apache.commons.math.linear
This class implements the FieldVector interface with a OpenIntToFieldHashMap backing store.
SparseFieldVector(Field<T>) - Constructor for class org.apache.commons.math.linear.SparseFieldVector
Build a 0-length vector.
SparseFieldVector(Field<T>, int) - Constructor for class org.apache.commons.math.linear.SparseFieldVector
Construct a (dimension)-length vector of zeros.
SparseFieldVector(Field<T>, int, int) - Constructor for class org.apache.commons.math.linear.SparseFieldVector
Build a vector with known the sparseness (for advanced use only).
SparseFieldVector(Field<T>, T[]) - Constructor for class org.apache.commons.math.linear.SparseFieldVector
Create from a Field array.
SparseFieldVector(SparseFieldVector<T>) - Constructor for class org.apache.commons.math.linear.SparseFieldVector
Copy constructor.
SparseFloatAlgebra - Class in cern.colt.matrix.tfloat.algo
Linear algebraic matrix operations operating on sparse matrices.
SparseFloatAlgebra() - Constructor for class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Constructs a new instance with an equality tolerance given by Property.DEFAULT.tolerance().
SparseFloatAlgebra(float) - Constructor for class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
Constructs a new instance with the given equality tolerance.
SparseFloatCholeskyDecomposition - Class in cern.colt.matrix.tfloat.algo.decomposition
For a symmetric, positive definite matrix A, the Cholesky decomposition is a lower triangular matrix L so that A = L*L'; If the matrix is not symmetric positive definite, the IllegalArgumentException is thrown.
SparseFloatCholeskyDecomposition(FloatMatrix2D, int) - Constructor for class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatCholeskyDecomposition
Constructs and returns a new Cholesky decomposition object for a sparse symmetric and positive definite matrix; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
SparseFloatLUDecomposition - Class in cern.colt.matrix.tfloat.algo.decomposition
For a square matrix A, the LU decomposition is an unit lower triangular matrix L, an upper triangular matrix U, and a permutation vector piv so that A(piv,:) = L*U
SparseFloatLUDecomposition(FloatMatrix2D, int, boolean) - Constructor for class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatLUDecomposition
Constructs and returns a new LU Decomposition object; The decomposed matrices can be retrieved via instance methods of the returned decomposition object.
SparseFloatMatrix1D - Class in cern.colt.matrix.tfloat.impl
Sparse hashed 1-d matrix (aka vector) holding float elements.
SparseFloatMatrix1D(float[]) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Constructs a matrix with a copy of the given values.
SparseFloatMatrix1D(int) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Constructs a matrix with a given number of cells.
SparseFloatMatrix1D(int, int, float, float) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
Constructs a matrix with a given number of parameters.
SparseFloatMatrix2D - Class in cern.colt.matrix.tfloat.impl
Sparse hashed 2-d matrix holding float elements.
SparseFloatMatrix2D(float[][]) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Constructs a matrix with a copy of the given values.
SparseFloatMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseFloatMatrix2D(int, int, int, float, float) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Constructs a matrix with a given number of rows and columns using memory as specified.
SparseFloatMatrix2D(int, int, int[], int[], float) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Constructs a matrix with a copy of the given indexes and a single value.
SparseFloatMatrix2D(int, int, int[], int[], float[]) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Constructs a matrix with a copy of the given indexes and values.
SparseFloatMatrix2D(MatrixVectorReader) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
Constructs a matrix from MatrixVectorReader.
SparseFloatMatrix3D - Class in cern.colt.matrix.tfloat.impl
Sparse hashed 3-d matrix holding float elements.
SparseFloatMatrix3D(float[][][]) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
Constructs a matrix with a copy of the given values.
SparseFloatMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseFloatMatrix3D(int, int, int, int, float, float) - Constructor for class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
Constructs a matrix with a given number of slices, rows and columns using memory as specified.
SparseFloatQRDecomposition - Class in cern.colt.matrix.tfloat.algo.decomposition
For an m x n matrix A with m >= n, the QR decomposition is an m x n orthogonal matrix Q and an n x n upper triangular matrix R so that A = Q*R.
SparseFloatQRDecomposition(FloatMatrix2D, int) - Constructor for class cern.colt.matrix.tfloat.algo.decomposition.SparseFloatQRDecomposition
Constructs and returns a new QR decomposition object; computed by Householder reflections; If m < n then then the QR of A' is computed.
SparseIntMatrix1D - Class in cern.colt.matrix.tint.impl
Sparse hashed 1-d matrix (aka vector) holding int elements.
SparseIntMatrix1D(int[]) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Constructs a matrix with a copy of the given values.
SparseIntMatrix1D(int) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Constructs a matrix with a given number of cells.
SparseIntMatrix1D(int, int, double, double) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix1D
Constructs a matrix with a given number of parameters.
SparseIntMatrix2D - Class in cern.colt.matrix.tint.impl
Sparse hashed 2-d matrix holding int elements.
SparseIntMatrix2D(int[][]) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Constructs a matrix with a copy of the given values.
SparseIntMatrix2D(int, int) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseIntMatrix2D(int, int, int, double, double) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Constructs a matrix with a given number of rows and columns using memory as specified.
SparseIntMatrix2D(int, int, int[], int[], int) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Constructs a matrix with a copy of the given indexes and a single value.
SparseIntMatrix2D(int, int, int[], int[], int[]) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Constructs a matrix with a copy of the given indexes and values.
SparseIntMatrix2D(MatrixVectorReader) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix2D
Constructs a matrix from MatrixVectorReader.
SparseIntMatrix3D - Class in cern.colt.matrix.tint.impl
Sparse hashed 3-d matrix holding int elements.
SparseIntMatrix3D(int[][][]) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix3D
Constructs a matrix with a copy of the given values.
SparseIntMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseIntMatrix3D(int, int, int, int, double, double) - Constructor for class cern.colt.matrix.tint.impl.SparseIntMatrix3D
Constructs a matrix with a given number of slices, rows and columns using memory as specified.
sparseIterator() - Method in class org.apache.commons.math.linear.AbstractRealVector
Specialized implementations may choose to not iterate over all dimensions, either because those values are unset, or are equal to defaultValue(), or are small enough to be ignored for the purposes of iteration.
sparseIterator() - Method in class org.apache.commons.math.linear.OpenMapRealVector
Specialized implementations may choose to not iterate over all dimensions, either because those values are unset, or are equal to defaultValue(), or are small enough to be ignored for the purposes of iteration.
sparseIterator() - Method in interface org.apache.commons.math.linear.RealVector
Specialized implementations may choose to not iterate over all dimensions, either because those values are unset, or are equal to defaultValue(), or are small enough to be ignored for the purposes of iteration.
SparseLongMatrix1D - Class in cern.colt.matrix.tlong.impl
Sparse hashed 1-d matrix (aka vector) holding long elements.
SparseLongMatrix1D(long[]) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Constructs a matrix with a copy of the given values.
SparseLongMatrix1D(int) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Constructs a matrix with a given number of cells.
SparseLongMatrix1D(int, int, double, double) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
Constructs a matrix with a given number of parameters.
SparseLongMatrix2D - Class in cern.colt.matrix.tlong.impl
Sparse hashed 2-d matrix holding long elements.
SparseLongMatrix2D(long[][]) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Constructs a matrix with a copy of the given values.
SparseLongMatrix2D(int, int) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseLongMatrix2D(int, int, int, double, double) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Constructs a matrix with a given number of rows and columns using memory as specified.
SparseLongMatrix2D(int, int, int[], int[], long) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Constructs a matrix with a copy of the given indexes and a single value.
SparseLongMatrix2D(int, int, int[], int[], long[]) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Constructs a matrix with a copy of the given indexes and values.
SparseLongMatrix2D(MatrixVectorReader) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
Constructs a matrix from MatrixVectorReader.
SparseLongMatrix3D - Class in cern.colt.matrix.tlong.impl
Sparse hashed 3-d matrix holding long elements.
SparseLongMatrix3D(long[][][]) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
Constructs a matrix with a copy of the given values.
SparseLongMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseLongMatrix3D(int, int, int, int, double, double) - Constructor for class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
Constructs a matrix with a given number of slices, rows and columns using memory as specified.
SparseObjectMatrix1D - Class in cern.colt.matrix.impl
Sparse hashed 1-d matrix (aka vector) holding Object elements.
SparseObjectMatrix1D(Object[]) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix1D
Constructs a matrix with a copy of the given values.
SparseObjectMatrix1D(int) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix1D
Constructs a matrix with a given number of cells.
SparseObjectMatrix1D(int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix1D
Constructs a matrix with a given number of parameters.
SparseObjectMatrix1D - Class in cern.colt.matrix.tobject.impl
Sparse hashed 1-d matrix (aka vector) holding Object elements.
SparseObjectMatrix1D(Object[]) - Constructor for class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Constructs a matrix with a copy of the given values.
SparseObjectMatrix1D(int) - Constructor for class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Constructs a matrix with a given number of cells.
SparseObjectMatrix1D(int, int, double, double) - Constructor for class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Constructs a matrix with a given number of parameters.
SparseObjectMatrix2D - Class in cern.colt.matrix.impl
Sparse hashed 2-d matrix holding Object elements.
SparseObjectMatrix2D(Object[][]) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix2D
Constructs a matrix with a copy of the given values.
SparseObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseObjectMatrix2D(int, int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix2D
Constructs a matrix with a given number of rows and columns using memory as specified.
SparseObjectMatrix2D - Class in cern.colt.matrix.tobject.impl
Sparse hashed 2-d matrix holding Object elements.
SparseObjectMatrix2D(Object[][]) - Constructor for class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Constructs a matrix with a copy of the given values.
SparseObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Constructs a matrix with a given number of rows and columns and default memory usage.
SparseObjectMatrix2D(int, int, int, double, double) - Constructor for class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Constructs a matrix with a given number of rows and columns using memory as specified.
SparseObjectMatrix3D - Class in cern.colt.matrix.impl
Sparse hashed 3-d matrix holding Object elements.
SparseObjectMatrix3D(Object[][][]) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix3D
Constructs a matrix with a copy of the given values.
SparseObjectMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseObjectMatrix3D(int, int, int, int, double, double) - Constructor for class cern.colt.matrix.impl.SparseObjectMatrix3D
Constructs a matrix with a given number of slices, rows and columns using memory as specified.
SparseObjectMatrix3D - Class in cern.colt.matrix.tobject.impl
Sparse hashed 3-d matrix holding Object elements.
SparseObjectMatrix3D(Object[][][]) - Constructor for class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Constructs a matrix with a copy of the given values.
SparseObjectMatrix3D(int, int, int) - Constructor for class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Constructs a matrix with a given number of slices, rows and columns and default memory usage.
SparseObjectMatrix3D(int, int, int, int, double, double) - Constructor for class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Constructs a matrix with a given number of slices, rows and columns using memory as specified.
SparseRCDComplexMatrix2D - Class in cern.colt.matrix.tdcomplex.impl
Sparse row-compressed 2-d matrix holding complex elements.
SparseRCDComplexMatrix2D(double[][]) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Constructs a matrix with a copy of the given values.
SparseRCDComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCDComplexMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCDComplexMatrix2D(int, int, int[], int[], double, double, boolean) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Constructs a matrix with indexes given in the coordinate format and single value.
SparseRCDComplexMatrix2D(int, int, int[], int[], double[], boolean, boolean) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseRCDComplexMatrix2D(int, int, int[], int[], double[]) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
Constructs a matrix with given parameters.
SparseRCDoubleMatrix2D - Class in cern.colt.matrix.tdouble.impl
Sparse row-compressed 2-d matrix holding double elements.
SparseRCDoubleMatrix2D(double[][]) - Constructor for class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Constructs a matrix with a copy of the given values.
SparseRCDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCDoubleMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCDoubleMatrix2D(int, int, int[], int[], double, boolean, boolean) - Constructor for class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Constructs a matrix with indexes given in the coordinate format and single value.
SparseRCDoubleMatrix2D(int, int, int[], int[], double[], boolean, boolean, boolean) - Constructor for class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseRCDoubleMatrix2D(int, int, int[], int[], double[]) - Constructor for class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
Constructs a matrix with given parameters.
SparseRCFComplexMatrix2D - Class in cern.colt.matrix.tfcomplex.impl
Sparse row-compressed 2-d matrix holding complex elements.
SparseRCFComplexMatrix2D(float[][]) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Constructs a matrix with a copy of the given values.
SparseRCFComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCFComplexMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCFComplexMatrix2D(int, int, int[], int[], float, float, boolean) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Constructs a matrix with indexes given in the coordinate format and single value.
SparseRCFComplexMatrix2D(int, int, int[], int[], float[], boolean, boolean) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseRCFComplexMatrix2D(int, int, int[], int[], float[]) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
Constructs a matrix with given parameters.
SparseRCFloatMatrix2D - Class in cern.colt.matrix.tfloat.impl
Sparse row-compressed 2-d matrix holding float elements.
SparseRCFloatMatrix2D(float[][]) - Constructor for class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Constructs a matrix with a copy of the given values.
SparseRCFloatMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCFloatMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCFloatMatrix2D(int, int, int[], int[], float, boolean, boolean) - Constructor for class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Constructs a matrix with indexes given in the coordinate format and single value.
SparseRCFloatMatrix2D(int, int, int[], int[], float[], boolean, boolean, boolean) - Constructor for class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseRCFloatMatrix2D(int, int, int[], int[], float[]) - Constructor for class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
Constructs a matrix with given parameters.
SparseRCIntMatrix2D - Class in cern.colt.matrix.tint.impl
Sparse row-compressed 2-d matrix holding int elements.
SparseRCIntMatrix2D(int[][]) - Constructor for class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Constructs a matrix with a copy of the given values.
SparseRCIntMatrix2D(int, int) - Constructor for class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCIntMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCIntMatrix2D(int, int, int[], int[], int, boolean, boolean) - Constructor for class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Constructs a matrix with indexes given in the coordinate format and single value.
SparseRCIntMatrix2D(int, int, int[], int[], int[], boolean, boolean, boolean) - Constructor for class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseRCIntMatrix2D(int, int, int[], int[], int[]) - Constructor for class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
Constructs a matrix with given parameters.
SparseRCLongMatrix2D - Class in cern.colt.matrix.tlong.impl
Sparse row-compressed 2-d matrix holding long elements.
SparseRCLongMatrix2D(long[][]) - Constructor for class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Constructs a matrix with a copy of the given values.
SparseRCLongMatrix2D(int, int) - Constructor for class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCLongMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCLongMatrix2D(int, int, int[], int[], long, boolean, boolean) - Constructor for class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Constructs a matrix with indexes given in the coordinate format and single value.
SparseRCLongMatrix2D(int, int, int[], int[], long[], boolean, boolean, boolean) - Constructor for class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseRCLongMatrix2D(int, int, int[], int[], long[]) - Constructor for class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
Constructs a matrix with given parameters.
SparseRCMDComplexMatrix2D - Class in cern.colt.matrix.tdcomplex.impl
Sparse row-compressed-modified 2-d matrix holding complex elements.
SparseRCMDComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdcomplex.impl.SparseRCMDComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCMDoubleMatrix2D - Class in cern.colt.matrix.tdouble.impl
Sparse row-compressed-modified 2-d matrix holding double elements.
SparseRCMDoubleMatrix2D(int, int) - Constructor for class cern.colt.matrix.tdouble.impl.SparseRCMDoubleMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCMFComplexMatrix2D - Class in cern.colt.matrix.tfcomplex.impl
Sparse row-compressed-modified 2-d matrix holding complex elements.
SparseRCMFComplexMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfcomplex.impl.SparseRCMFComplexMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCMFloatMatrix2D - Class in cern.colt.matrix.tfloat.impl
Sparse row-compressed-modified 2-d matrix holding float elements.
SparseRCMFloatMatrix2D(int, int) - Constructor for class cern.colt.matrix.tfloat.impl.SparseRCMFloatMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCMIntMatrix2D - Class in cern.colt.matrix.tint.impl
Sparse row-compressed-modified 2-d matrix holding int elements.
SparseRCMIntMatrix2D(int, int) - Constructor for class cern.colt.matrix.tint.impl.SparseRCMIntMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCMLongMatrix2D - Class in cern.colt.matrix.tlong.impl
Sparse row-compressed-modified 2-d matrix holding long elements.
SparseRCMLongMatrix2D(int, int) - Constructor for class cern.colt.matrix.tlong.impl.SparseRCMLongMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCMObjectMatrix2D - Class in cern.colt.matrix.tobject.impl
Sparse row-compressed-modified 2-d matrix holding Object elements.
SparseRCMObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.tobject.impl.SparseRCMObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCObjectMatrix2D - Class in cern.colt.matrix.tobject.impl
Sparse row-compressed 2-d matrix holding Object elements.
SparseRCObjectMatrix2D(Object[][]) - Constructor for class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Constructs a matrix with a copy of the given values.
SparseRCObjectMatrix2D(int, int) - Constructor for class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCObjectMatrix2D(int, int, int) - Constructor for class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Constructs a matrix with a given number of rows and columns.
SparseRCObjectMatrix2D(int, int, int[], int[], Object, boolean) - Constructor for class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Constructs a matrix with indexes given in the coordinate format and single value.
SparseRCObjectMatrix2D(int, int, int[], int[], Object[], boolean, boolean) - Constructor for class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Constructs a matrix with indexes and values given in the coordinate format.
SparseRCObjectMatrix2D(int, int, int[], int[], Object[]) - Constructor for class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
Constructs a matrix with given parameters.
SparseRealMatrix - Interface in org.apache.commons.math.linear
Marker interface for RealMatrix implementations that require sparse backing storage
SparseRealVector - Interface in org.apache.commons.math.linear
Marker interface for RealVectors that require sparse backing storage
spbcon(String, int, int, float[], int, float, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
spbequ(String, int, int, float[], int, float[], floatW, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
spbrfs(String, int, int, int, float[], int, float[], int, float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
spbstf(String, int, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
spbsv(String, int, int, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
spbsvx(String, String, int, int, int, float[], int, float[], int, StringW, float[], float[], int, float[], int, floatW, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
spbtf2(String, int, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
spbtrf(String, int, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
spbtrs(String, int, int, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
SpearmansCorrelation - Class in org.apache.commons.math.stat.correlation
Spearman's rank correlation.
SpearmansCorrelation(RealMatrix, RankingAlgorithm) - Constructor for class org.apache.commons.math.stat.correlation.SpearmansCorrelation
Create a SpearmansCorrelation with the given input data matrix and ranking algorithm.
SpearmansCorrelation(RealMatrix) - Constructor for class org.apache.commons.math.stat.correlation.SpearmansCorrelation
Create a SpearmansCorrelation from the given data matrix.
SpearmansCorrelation() - Constructor for class org.apache.commons.math.stat.correlation.SpearmansCorrelation
Create a SpearmansCorrelation without data.
Sphere - Class in jhplot.v3d
Build a sphere.
Sphere(Model3d, float, int, int) - Constructor for class jhplot.v3d.Sphere
Build a sphere.
SplayTree - Class in umontreal.iro.lecuyer.simevents.eventlist
An implementation of EventList using a splay tree.
SplayTree() - Constructor for class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
SplineInterpolator - Class in org.apache.commons.math.analysis.interpolation
Computes a natural (also known as "free", "unclamped") cubic spline interpolation for the data set.
SplineInterpolator() - Constructor for class org.apache.commons.math.analysis.interpolation.SplineInterpolator
 
split(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Splits (partitions) a list into sublists such that each sublist contains the elements with a given range.
split(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Splits (partitions) a list into sublists such that each sublist contains the elements with a given range.
split(FloatArrayList, FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Splits (partitions) a list into sublists such that each sublist contains the elements with a given range.
splitApproximately(DoubleArrayList, int) - Method in class cern.hep.aida.bin.QuantileBin1D
Divides (rebins) a copy of the receiver at the given percentage boundaries into bins and returns these bins, such that each bin approximately reflects the data elements of its range.
splitApproximately(IAxis, int) - Method in class cern.hep.aida.bin.QuantileBin1D
Divides (rebins) a copy of the receiver at the given interval boundaries into bins and returns these bins, such that each bin approximately reflects the data elements of its range.
splitApproximately(DoubleArrayList, int) - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Divides (rebins) a copy of the receiver at the given percentage boundaries into bins and returns these bins, such that each bin approximately reflects the data elements of its range.
splitApproximately(DoubleIAxis, int) - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Divides (rebins) a copy of the receiver at the given interval boundaries into bins and returns these bins, such that each bin approximately reflects the data elements of its range.
splitApproximately(FloatArrayList, int) - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Divides (rebins) a copy of the receiver at the given percentage boundaries into bins and returns these bins, such that each bin approximately reflects the data elements of its range.
splitApproximately(FloatIAxis, int) - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Divides (rebins) a copy of the receiver at the given interval boundaries into bins and returns these bins, such that each bin approximately reflects the data elements of its range.
SPlot - Class in jhplot
A class to build a simple canvas with data points.
SPlot() - Constructor for class jhplot.SPlot
Construct a frame with a canvas.
SPlot(File) - Constructor for class jhplot.SPlot
Construct a frame with a canvas and open XML file with the data.
SPlot(int, int) - Constructor for class jhplot.SPlot
Construct a frame with the plot.
SPlot(String, int, int) - Constructor for class jhplot.SPlot
Construct a frame with the plot.
spocon(String, int, float[], int, float, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
spoequ(int, float[], int, float[], floatW, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
sporfs(String, int, int, float[], int, float[], int, float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sposv(String, int, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sposvx(String, String, int, int, float[], int, float[], int, StringW, float[], float[], int, float[], int, floatW, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
spotf2(String, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
spotrf(String, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
spotri(String, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
spotrs(String, int, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sppcon(String, int, float[], float, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sppequ(String, int, float[], float[], floatW, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
spprfs(String, int, int, float[], float[], float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sppsv(String, int, int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sppsvx(String, String, int, int, float[], float[], StringW, float[], float[], int, float[], int, floatW, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
spptrf(String, int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
spptri(String, int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
spptrs(String, int, int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
SPsheet - Class in jhplot
A spreadsheet class to display the data.
SPsheet() - Constructor for class jhplot.SPsheet
Show empty spreadsheet
SPsheet(P1D) - Constructor for class jhplot.SPsheet
Build a spreadsheet from the P1D container
SPsheet(CSVReader) - Constructor for class jhplot.SPsheet
Open spreadsheet and load csv file
SPsheet(H1D) - Constructor for class jhplot.SPsheet
Build a spreadsheet from the H1D histogram
SPsheet(F1D) - Constructor for class jhplot.SPsheet
Build a spreadsheet from the F1D function
SPsheet(DataHolder) - Constructor for class jhplot.SPsheet
Build a spreadsheet from multidimensional data holder
sptcon(int, float[], float[], float, floatW, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
spteqr(String, int, float[], float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sptrfs(int, int, float[], float[], float[], float[], float[], int, float[], int, float[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sptsv(int, int, float[], float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sptsvx(String, int, int, float[], float[], float[], float[], float[], int, float[], int, floatW, float[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
spttrf(int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
spttrs(int, int, float[], float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sptts2(int, int, float[], float[], float[], int) - Method in class org.netlib.lapack.LAPACK
..
SQLiteBrowser - Class in jhplot.io.sqlite
A browser to display SQLite databases (v3) created using either native C++ code or SQLjet java library
SQLiteBrowser(String) - Constructor for class jhplot.io.sqlite.SQLiteBrowser
Open SQLite file in a pop-up browser
sqrt - Static variable in class cern.jet.math.Functions
Function that returns Math.sqrt(a).
sqrt(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
sqrt - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
sqrt - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.sqrt(a).
sqrt(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
sqrt - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
sqrt - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.sqrt(a).
sqrt(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
sqrt() - Method in class flanagan.analysis.Stat
 
sqrt() - Method in class flanagan.math.ArrayMaths
 
sqrt() - Method in class jhplot.math.Complex
Complex square root (doesn't change this complex number).
sqrt(ValueErr) - Static method in class jhplot.math.ValueErr
Get square root value
SQRT - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.sqrt method wrapped as a ComposableFunction.
sqrt() - Method in class org.apache.commons.math.complex.Complex
Compute the square root of this complex number.
sqrt() - Method in class org.apache.commons.math.dfp.Dfp
Compute the square root.
sqrt(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the square root of a number.
sqrt1z() - Method in class org.apache.commons.math.complex.Complex
Compute the square root of 1 - this2 for this complex number.
SQRT_2 - Static variable in interface jhplot.math.num.Constants
√2.
sqrteps - Static variable in class cern.colt.matrix.tdouble.algo.solver.DoubleCGLS
 
sqrteps - Static variable in class cern.colt.matrix.tdouble.algo.solver.DoubleMRNSD
 
sqrteps - Static variable in class cern.colt.matrix.tfloat.algo.solver.FloatCGLS
 
sqrteps - Static variable in class cern.colt.matrix.tfloat.algo.solver.FloatMRNSD
 
SqrtMathFunction - Class in umontreal.iro.lecuyer.functions
Represents a function computing the square root of another function f (x).
SqrtMathFunction(MathFunction) - Constructor for class umontreal.iro.lecuyer.functions.SqrtMathFunction
Computes and returns the square root of the function func.
square - Static variable in class cern.jet.math.Functions
Function that returns a * a.
square - Static variable in class cern.jet.math.IntFunctions
Function that returns a * a.
square(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
square - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
square - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns a * a.
square(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
square - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
square - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns a * a.
square - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a * a.
square - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a * a.
square() - Method in class flanagan.analysis.ErrorProp
 
square(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
square(double) - Static method in class flanagan.math.Fmath
 
square(float) - Static method in class flanagan.math.Fmath
 
square(BigDecimal) - Static method in class flanagan.math.Fmath
 
square(int) - Static method in class flanagan.math.Fmath
 
square(long) - Static method in class flanagan.math.Fmath
 
square(BigInteger) - Static method in class flanagan.math.Fmath
 
square() - Method in class jhplot.math.ValueErr
Square
square(ValueErr) - Static method in class jhplot.math.ValueErr
Square
SquareMathFunction - Class in umontreal.iro.lecuyer.functions
Represents a function computing (af (x) + b)2 for a user-defined function f (x).
SquareMathFunction(MathFunction) - Constructor for class umontreal.iro.lecuyer.functions.SquareMathFunction
Constructs a new square function for function func.
SquareMathFunction(MathFunction, double, double) - Constructor for class umontreal.iro.lecuyer.functions.SquareMathFunction
Constructs a new power function for function func, and constants a and b.
squareRootElements(double[]) - Static method in class flanagan.math.Fmath
 
squareRootElements(float[]) - Static method in class flanagan.math.Fmath
 
sr - Static variable in class cern.clhep.Units
 
srot(int, float[], int, float[], int, float, float) - Method in class org.netlib.blas.BLAS
..
srotg(floatW, floatW, floatW, floatW) - Method in class org.netlib.blas.BLAS
..
srotm(int, float[], int, float[], int, float[]) - Method in class org.netlib.blas.BLAS
..
srotmg(floatW, floatW, floatW, float, float[]) - Method in class org.netlib.blas.BLAS
..
srscl(int, float, float[], int) - Method in class org.netlib.lapack.LAPACK
..
ssaitr(intW, String, int, int, int, int, float[], floatW, float[], int, float[], int, int[], float[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
ssapps(int, int, int, float[], float[], int, float[], int, float[], float[], int, float[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
ssaup2(intW, String, int, String, intW, intW, float, float[], int, int, int, intW, float[], int, float[], int, float[], float[], float[], int, float[], int[], float[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
ssaupd(intW, String, int, String, int, floatW, float[], int, float[], int, int[], int[], float[], float[], int, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
ssbev(String, String, int, int, float[], int, float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssbevd(String, String, int, int, float[], int, float[], float[], int, float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssbevx(String, String, String, int, int, float[], int, float[], int, float, float, int, int, float, intW, float[], float[], int, float[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssbgst(String, String, int, int, int, float[], int, float[], int, float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssbgv(String, String, int, int, int, float[], int, float[], int, float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssbgvd(String, String, int, int, int, float[], int, float[], int, float[], float[], int, float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssbgvx(String, String, String, int, int, int, float[], int, float[], int, float[], int, float, float, int, int, float, intW, float[], float[], int, float[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssbmv(String, int, int, float, float[], int, float[], int, float, float[], int) - Method in class org.netlib.blas.BLAS
..
ssbtrd(String, String, int, int, float[], int, float[], float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sscal(int, float, float[], int) - Method in class org.netlib.blas.BLAS
..
ssconv(int, float[], float[], float, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
sseigt(float, int, float[], int, float[], float[], float[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
ssesrt(String, boolean, int, float[], int, float[], int) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
sseupd(boolean, String, boolean[], float[], float[], int, float, String, int, String, intW, float, float[], int, float[], int, int[], int[], float[], float[], int, intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
ssgets(int, String, intW, intW, float[], float[], float[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
SSJCategorySeriesCollection - Class in umontreal.iro.lecuyer.charts
Stores data used in a CategoryChart.
SSJCategorySeriesCollection() - Constructor for class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
 
SSJInterpretationOracle - Class in umontreal.iro.lecuyer.simprocs
Determines which classes should be interpreted by the DSOL interpreter during process simulation.
SSJInterpretationOracle() - Constructor for class umontreal.iro.lecuyer.simprocs.SSJInterpretationOracle
 
SSJXYSeriesCollection - Class in umontreal.iro.lecuyer.charts
Stores data used in a XYChart.
SSJXYSeriesCollection() - Constructor for class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
 
ssortc(String, boolean, int, float[], float[], float[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
ssortr(String, boolean, int, float[], float[]) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
sspcon(String, int, float[], int[], float, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sspev(String, String, int, float[], float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sspevd(String, String, int, float[], float[], float[], int, float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sspevx(String, String, String, int, float[], float, float, int, int, float, intW, float[], float[], int, float[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sspgst(int, String, int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sspgv(int, String, String, int, float[], float[], float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sspgvd(int, String, String, int, float[], float[], float[], float[], int, float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sspgvx(int, String, String, String, int, float[], float[], float, float, int, int, float, intW, float[], float[], int, float[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sspmv(String, int, float, float[], float[], int, float, float[], int) - Method in class org.netlib.blas.BLAS
..
sspr(String, int, float, float[], int, float[]) - Method in class org.netlib.blas.BLAS
..
sspr2(String, int, float, float[], int, float[], int, float[]) - Method in class org.netlib.blas.BLAS
..
ssprfs(String, int, int, float[], float[], int[], float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sspsv(String, int, int, float[], int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sspsvx(String, String, int, int, float[], float[], int[], float[], int, float[], int, floatW, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssptrd(String, int, float[], float[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssptrf(String, int, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssptri(String, int, float[], int[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssptrs(String, int, int, float[], int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sstatn() - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
sstats() - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
sstebz(String, String, int, float, float, int, int, float, float[], float[], intW, intW, float[], int[], int[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sstedc(String, int, float[], float[], float[], int, float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sstegr(String, String, int, float[], float[], float, float, int, int, float, intW, float[], float[], int, int[], float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sstein(int, float[], float[], int, float[], int[], int[], float[], int, float[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sstemr(String, String, int, float[], float[], float, float, int, int, intW, float[], float[], int, int, int[], booleanW, float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssteqr(String, int, float[], float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssterf(int, float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sstev(String, int, float[], float[], float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
sstevd(String, int, float[], float[], float[], int, float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sstevr(String, String, int, float[], float[], float, float, int, int, float, intW, float[], float[], int, int[], float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sstevx(String, String, int, float[], float[], float, float, int, int, float, intW, float[], float[], int, float[], int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
sstqrb(int, float[], float[], float[], float[], intW) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
sswap(int, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
ssycon(String, int, float[], int, int[], float, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssyev(String, String, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssyevd(String, String, int, float[], int, float[], float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssyevr(String, String, String, int, float[], int, float, float, int, int, float, intW, float[], float[], int, int[], float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssyevx(String, String, String, int, float[], int, float, float, int, int, float, intW, float[], float[], int, float[], int, int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssygs2(int, String, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssygst(int, String, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssygv(int, String, String, int, float[], int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssygvd(int, String, String, int, float[], int, float[], int, float[], float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssygvx(int, String, String, String, int, float[], int, float[], int, float, float, int, int, float, intW, float[], float[], int, float[], int, int[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssymm(String, String, int, int, float, float[], int, float[], int, float, float[], int) - Method in class org.netlib.blas.BLAS
..
ssymv(String, int, float, float[], int, float[], int, float, float[], int) - Method in class org.netlib.blas.BLAS
..
ssyr(String, int, float, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
ssyr2(String, int, float, float[], int, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
ssyr2k(String, String, int, int, float, float[], int, float[], int, float, float[], int) - Method in class org.netlib.blas.BLAS
..
ssyrfs(String, int, int, float[], int, float[], int, int[], float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssyrk(String, String, int, int, float, float[], int, float, float[], int) - Method in class org.netlib.blas.BLAS
..
ssysv(String, int, int, float[], int, int[], float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssysvx(String, String, int, int, float[], int, float[], int, int[], float[], int, float[], int, floatW, float[], float[], float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssytd2(String, int, float[], int, float[], float[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssytf2(String, int, float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssytrd(String, int, float[], int, float[], float[], float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssytrf(String, int, float[], int, int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
ssytri(String, int, float[], int, int[], float[], intW) - Method in class org.netlib.lapack.LAPACK
..
ssytrs(String, int, int, float[], int, int[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
stanadardError() - Method in class flanagan.math.Matrix
 
standardDeviation() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the sample standard deviation, which is Math.sqrt(variance()).
standardDeviation(double) - Static method in class cern.jet.stat.Descriptive
Returns the standard deviation from a variance.
standardDeviation(double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the standard deviation from a variance.
standardDeviation(float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the standard deviation from a variance.
standardDeviation() - Method in class flanagan.analysis.ProbabilityPlot
 
standardDeviation() - Method in class flanagan.analysis.Stat
 
standardDeviation(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(Complex[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(double[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(float[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(int[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(long[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(BigDecimal[], BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(BigInteger[], BigInteger[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(double[], double[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation(float[], float[]) - Static method in class flanagan.analysis.Stat
 
standardDeviation() - Method in class flanagan.math.Matrix
 
standardDeviation() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns the sample standard deviation, which is Math.sqrt(variance()).
standardDeviation() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns the sample standard deviation, which is Math.sqrt(variance()).
standardDeviation(double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the (bias-corrected sample) standard deviation of an array.
standardDeviation(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns the (bias-corrected sample) standard deviation of an array.
StandardDeviation - Class in org.apache.commons.math.stat.descriptive.moment
Computes the sample standard deviation.
StandardDeviation() - Constructor for class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Constructs a StandardDeviation.
StandardDeviation(SecondMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Constructs a StandardDeviation from an external second moment.
StandardDeviation(StandardDeviation) - Constructor for class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Copy constructor, creates a new StandardDeviation identical to the original
StandardDeviation(boolean) - Constructor for class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Contructs a StandardDeviation with the specified value for the isBiasCorrected property.
StandardDeviation(boolean, SecondMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.StandardDeviation
Contructs a StandardDeviation with the specified value for the isBiasCorrected property and the supplied external moment.
standardDeviation(double[]) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
For each tally in this list, computes the sample standard deviation, and stores the standard deviations into the array std.
standardDeviation() - Method in class umontreal.iro.lecuyer.stat.Tally
Returns the sample standard deviation of the observations since the last initialization.
standardDeviation_as_Complex() - Method in class flanagan.analysis.Stat
 
standardDeviation_as_Complex_ConjugateCalcn() - Method in class flanagan.analysis.Stat
 
standardDeviation_as_double() - Method in class flanagan.analysis.Stat
 
standardDeviation_of_ComplexImaginaryParts() - Method in class flanagan.analysis.Stat
 
standardDeviation_of_ComplexModuli() - Method in class flanagan.analysis.Stat
 
standardDeviation_of_ComplexRealParts() - Method in class flanagan.analysis.Stat
 
standardDeviationConjugateCalcn(Complex[]) - Static method in class flanagan.analysis.Stat
 
standardDeviationConjugateCalcn(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
standardDeviationImaginaryParts(Complex[]) - Static method in class flanagan.analysis.Stat
 
standardDeviationImaginaryParts(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
standardDeviationModuli(Complex[]) - Static method in class flanagan.analysis.Stat
 
standardDeviationModuli(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
standardDeviationRealParts(Complex[]) - Static method in class flanagan.analysis.Stat
 
standardDeviationRealParts(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
standardError() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the sample standard error, which is Math.sqrt(variance() / size())
standardError(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the standard error of a data sequence.
standardError(int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the standard error of a data sequence.
standardError(int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the standard error of a data sequence.
standardError() - Method in class flanagan.analysis.Stat
 
standardError(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
standardError(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
standardError(Complex[]) - Static method in class flanagan.analysis.Stat
 
standardError(double[]) - Static method in class flanagan.analysis.Stat
 
standardError(float[]) - Static method in class flanagan.analysis.Stat
 
standardError(int[]) - Static method in class flanagan.analysis.Stat
 
standardError(long[]) - Static method in class flanagan.analysis.Stat
 
standardError(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
standardError(BigDecimal[], BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
standardError(BigInteger[], BigInteger[]) - Static method in class flanagan.analysis.Stat
 
standardError(double[], double[]) - Static method in class flanagan.analysis.Stat
 
standardError(float[], float[]) - Static method in class flanagan.analysis.Stat
 
standardError() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns the sample standard error, which is Math.sqrt(variance() / size())
standardError() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns the sample standard error, which is Math.sqrt(variance() / size())
standardError() - Method in class jhplot.P0D
Returns the sample standard error, which is Math.sqrt(variance() / size()).
standardError() - Method in class jhplot.P0I
Returns the sample standard error, which is Math.sqrt(variance() / size()).
standardError_as_Complex() - Method in class flanagan.analysis.Stat
 
standardError_as_Complex_ConjugateCalcn() - Method in class flanagan.analysis.Stat
 
standardError_as_double() - Method in class flanagan.analysis.Stat
 
standardError_of_ComplexImaginaryParts() - Method in class flanagan.analysis.Stat
 
standardError_of_ComplexModuli() - Method in class flanagan.analysis.Stat
 
standardError_of_ComplexRealParts() - Method in class flanagan.analysis.Stat
 
standardErrorConjugateCalcn(Complex[]) - Static method in class flanagan.analysis.Stat
 
standardErrorConjugateCalcn(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
standardErrorImaginaryParts(Complex[]) - Static method in class flanagan.analysis.Stat
 
standardErrorImaginaryParts(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
standardErrorModuli(Complex[]) - Static method in class flanagan.analysis.Stat
 
standardErrorModuli(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
standardErrorRealParts(Complex[]) - Static method in class flanagan.analysis.Stat
 
standardErrorRealParts(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
standardise() - Method in class flanagan.analysis.Stat
 
standardise(double[]) - Static method in class flanagan.analysis.Stat
 
standardise(float[]) - Static method in class flanagan.analysis.Stat
 
standardise(long[]) - Static method in class flanagan.analysis.Stat
 
standardise(int[]) - Static method in class flanagan.analysis.Stat
 
standardise(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
standardise(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
standardisedAlpha() - Method in class flanagan.analysis.Cronbach
 
standardisedAverageCorrelationCoefficients() - Method in class flanagan.analysis.Scores
 
standardisedAverageCorrelationCoefficientsWithTotals() - Method in class flanagan.analysis.Scores
 
standardisedCorrelationCoefficient(String, String) - Method in class flanagan.analysis.Scores
 
standardisedCorrelationCoefficient(int, int) - Method in class flanagan.analysis.Scores
 
standardisedCorrelationCoefficient(String) - Method in class flanagan.analysis.Scores
 
standardisedCorrelationCoefficient(int) - Method in class flanagan.analysis.Scores
 
standardisedCorrelationCoefficients() - Method in class flanagan.analysis.Scores
 
standardisedCovariance(String, String) - Method in class flanagan.analysis.Scores
 
standardisedCovariance(int, int) - Method in class flanagan.analysis.Scores
 
standardisedCovariance(String) - Method in class flanagan.analysis.Scores
 
standardisedCovariance(int) - Method in class flanagan.analysis.Scores
 
standardisedCovariances() - Method in class flanagan.analysis.Scores
 
standardisedItemItemPlot(String, String) - Method in class flanagan.analysis.Scores
 
standardisedItemItemPlot(int, int) - Method in class flanagan.analysis.Scores
 
standardisedItemMaxima() - Method in class flanagan.analysis.Scores
 
standardisedItemMaximum(int) - Method in class flanagan.analysis.Scores
 
standardisedItemMean(String) - Method in class flanagan.analysis.Scores
 
standardisedItemMean(int) - Method in class flanagan.analysis.Scores
 
standardisedItemMeans() - Method in class flanagan.analysis.Scores
 
standardisedItemMeansPlot(String) - Method in class flanagan.analysis.Scores
 
standardisedItemMeansPlot(int) - Method in class flanagan.analysis.Scores
 
standardisedItemMedian(String) - Method in class flanagan.analysis.Scores
 
standardisedItemMedian(int) - Method in class flanagan.analysis.Scores
 
standardisedItemMedians() - Method in class flanagan.analysis.Scores
 
standardisedItemMinima() - Method in class flanagan.analysis.Scores
 
standardisedItemMinimum(int) - Method in class flanagan.analysis.Scores
 
standardisedItemRange(int) - Method in class flanagan.analysis.Scores
 
standardisedItemRanges() - Method in class flanagan.analysis.Scores
 
standardisedItemStandardDeviation(String) - Method in class flanagan.analysis.Scores
 
standardisedItemStandardDeviation(int) - Method in class flanagan.analysis.Scores
 
standardisedItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardisedItemTotal(String) - Method in class flanagan.analysis.Scores
 
standardisedItemTotal(int) - Method in class flanagan.analysis.Scores
 
standardisedItemTotals() - Method in class flanagan.analysis.Scores
 
standardisedItemVariance(String) - Method in class flanagan.analysis.Scores
 
standardisedItemVariance(int) - Method in class flanagan.analysis.Scores
 
standardisedItemVariances() - Method in class flanagan.analysis.Scores
 
standardisedMaximumOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardisedMaximumOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardisedMaximumOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardisedMaximumOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardisedMaximumOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardisedMaximumOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardisedMaximumOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardisedMeanOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardisedMeanOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardisedMeanOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardisedMeanOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardisedMeanOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardisedMeanOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardisedMeanOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardisedMeanOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardisedMinimumOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardisedMinimumOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardisedMinimumOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardisedMinimumOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardisedMinimumOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardisedMinimumOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardisedMinimumOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardisedMinimumOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardisedPersonMaxima() - Method in class flanagan.analysis.Scores
 
standardisedPersonMaximum(int) - Method in class flanagan.analysis.Scores
 
standardisedPersonMean(int) - Method in class flanagan.analysis.Scores
 
standardisedPersonMeans() - Method in class flanagan.analysis.Scores
 
standardisedPersonMinima() - Method in class flanagan.analysis.Scores
 
standardisedPersonMinimum(int) - Method in class flanagan.analysis.Scores
 
standardisedPersonRange(int) - Method in class flanagan.analysis.Scores
 
standardisedPersonRanges() - Method in class flanagan.analysis.Scores
 
standardisedPersonStandardDeviation(int) - Method in class flanagan.analysis.Scores
 
standardisedPersonStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardisedPersonTotal(int) - Method in class flanagan.analysis.Scores
 
standardisedPersonTotals() - Method in class flanagan.analysis.Scores
 
standardisedPersonVariance(int) - Method in class flanagan.analysis.Scores
 
standardisedPersonVariances() - Method in class flanagan.analysis.Scores
 
standardisedRangeOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardisedRangeOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardisedRangeOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardisedRangeOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardisedRangeOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardisedRangeOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardisedRangeOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardisedRangeOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardisedScoresAsRowPerItem() - Method in class flanagan.analysis.Scores
 
standardisedScoresAsRowPerPerson() - Method in class flanagan.analysis.Scores
 
standardisedStanadarDeviationOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardisedStanadarDeviationOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardisedStanadarDeviationOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardisedStanadarDeviationOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardisedStanadarDeviationOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardisedStanadarDeviationOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardisedStanadarDeviationOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardisedStanadarDeviationOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardisedStandardDeviationCorrelationCoefficients() - Method in class flanagan.analysis.Scores
 
standardisedStandardDeviationCorrelationCoefficientsWithTotals() - Method in class flanagan.analysis.Scores
 
standardisedTotalMaximum() - Method in class flanagan.analysis.Scores
 
standardisedTotalMean() - Method in class flanagan.analysis.Scores
 
standardisedTotalMinimum() - Method in class flanagan.analysis.Scores
 
standardisedTotalRange() - Method in class flanagan.analysis.Scores
 
standardisedTotalStandardDeviation() - Method in class flanagan.analysis.Scores
 
standardisedTotalTotal() - Method in class flanagan.analysis.Scores
 
standardisedTotalVariance() - Method in class flanagan.analysis.Scores
 
standardisedVarianceOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardisedVarianceOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardisedVarianceOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardisedVarianceOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardisedVarianceOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardisedVarianceOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardisedVarianceOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardisedVarianceOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardize(double, double) - Method in class cern.hep.aida.bin.DynamicBin1D
Modifies the receiver to be standardized.
standardize(DoubleArrayList, double, double) - Static method in class cern.jet.stat.Descriptive
Modifies a data sequence to be standardized.
standardize(DoubleArrayList, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Modifies a data sequence to be standardized.
standardize(FloatArrayList, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Modifies a data sequence to be standardized.
standardize() - Method in class flanagan.analysis.Stat
 
standardize(double[]) - Static method in class flanagan.analysis.Stat
 
standardize(float[]) - Static method in class flanagan.analysis.Stat
 
standardize(long[]) - Static method in class flanagan.analysis.Stat
 
standardize(int[]) - Static method in class flanagan.analysis.Stat
 
standardize(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
standardize(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
standardize(double, double) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Modifies the receiver to be standardized.
standardize(float, float) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Modifies the receiver to be standardized.
standardize(PND) - Method in class jhplot.HNeuralNet
Standardize each column.
standardize() - Method in class jhplot.PND
Standardize each column.
standardizedAllResponsesMaximum() - Method in class flanagan.analysis.Scores
 
standardizedAllResponsesMean() - Method in class flanagan.analysis.Scores
 
standardizedAllResponsesMinimum() - Method in class flanagan.analysis.Scores
 
standardizedAllResponsesRange() - Method in class flanagan.analysis.Scores
 
standardizedAllResponsesStandardDeviation() - Method in class flanagan.analysis.Scores
 
standardizedAllResponsesTotal() - Method in class flanagan.analysis.Scores
 
standardizedAllResponsesVariance() - Method in class flanagan.analysis.Scores
 
standardizedAlpha() - Method in class flanagan.analysis.Cronbach
 
standardizedAverageCorrelationCoefficients() - Method in class flanagan.analysis.Scores
 
standardizedAverageCorrelationCoefficientsWithTotals() - Method in class flanagan.analysis.Scores
 
standardizedCorrelationCoefficient(String, String) - Method in class flanagan.analysis.Scores
 
standardizedCorrelationCoefficient(int, int) - Method in class flanagan.analysis.Scores
 
standardizedCorrelationCoefficient(String) - Method in class flanagan.analysis.Scores
 
standardizedCorrelationCoefficient(int) - Method in class flanagan.analysis.Scores
 
standardizedCorrelationCoefficients() - Method in class flanagan.analysis.Scores
 
standardizedCovariance(String, String) - Method in class flanagan.analysis.Scores
 
standardizedCovariance(int, int) - Method in class flanagan.analysis.Scores
 
standardizedCovariance(String) - Method in class flanagan.analysis.Scores
 
standardizedCovariance(int) - Method in class flanagan.analysis.Scores
 
standardizedCovariances() - Method in class flanagan.analysis.Scores
 
standardizedItemItemPlot(String, String) - Method in class flanagan.analysis.Scores
 
standardizedItemItemPlot(int, int) - Method in class flanagan.analysis.Scores
 
standardizedItemMaxima() - Method in class flanagan.analysis.Scores
 
standardizedItemMaximum(int) - Method in class flanagan.analysis.Scores
 
standardizedItemMean(String) - Method in class flanagan.analysis.Scores
 
standardizedItemMean(int) - Method in class flanagan.analysis.Scores
 
standardizedItemMeans() - Method in class flanagan.analysis.Scores
 
standardizedItemMeansPlot(String) - Method in class flanagan.analysis.Scores
 
standardizedItemMeansPlot(int) - Method in class flanagan.analysis.Scores
 
standardizedItemMedian(String) - Method in class flanagan.analysis.Scores
 
standardizedItemMedian(int) - Method in class flanagan.analysis.Scores
 
standardizedItemMedians() - Method in class flanagan.analysis.Scores
 
standardizedItemMinima() - Method in class flanagan.analysis.Scores
 
standardizedItemMinimum(int) - Method in class flanagan.analysis.Scores
 
standardizedItemRange(int) - Method in class flanagan.analysis.Scores
 
standardizedItemRanges() - Method in class flanagan.analysis.Scores
 
standardizedItemStandardDeviation(String) - Method in class flanagan.analysis.Scores
 
standardizedItemStandardDeviation(int) - Method in class flanagan.analysis.Scores
 
standardizedItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardizedItemTotal(String) - Method in class flanagan.analysis.Scores
 
standardizedItemTotal(int) - Method in class flanagan.analysis.Scores
 
standardizedItemTotals() - Method in class flanagan.analysis.Scores
 
standardizedItemVariance(String) - Method in class flanagan.analysis.Scores
 
standardizedItemVariance(int) - Method in class flanagan.analysis.Scores
 
standardizedItemVariances() - Method in class flanagan.analysis.Scores
 
standardizedMaximumOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardizedMaximumOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardizedMaximumOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardizedMaximumOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardizedMaximumOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardizedMaximumOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardizedMaximumOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardizedMaximumOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardizedMeanOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardizedMeanOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardizedMeanOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardizedMeanOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardizedMeanOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardizedMeanOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardizedMeanOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardizedMeanOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardizedMinimumOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardizedMinimumOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardizedMinimumOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardizedMinimumOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardizedMinimumOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardizedMinimumOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardizedMinimumOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardizedMinimumOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardizedOriginalData() - Method in class flanagan.analysis.BoxCox
 
standardizedPersonMaxima() - Method in class flanagan.analysis.Scores
 
standardizedPersonMaximum(int) - Method in class flanagan.analysis.Scores
 
standardizedPersonMean(int) - Method in class flanagan.analysis.Scores
 
standardizedPersonMeans() - Method in class flanagan.analysis.Scores
 
standardizedPersonMinima() - Method in class flanagan.analysis.Scores
 
standardizedPersonMinimum(int) - Method in class flanagan.analysis.Scores
 
standardizedPersonRange(int) - Method in class flanagan.analysis.Scores
 
standardizedPersonRanges() - Method in class flanagan.analysis.Scores
 
standardizedPersonStandardDeviation(int) - Method in class flanagan.analysis.Scores
 
standardizedPersonStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardizedPersonTotal(int) - Method in class flanagan.analysis.Scores
 
standardizedPersonTotals() - Method in class flanagan.analysis.Scores
 
standardizedPersonVariance(int) - Method in class flanagan.analysis.Scores
 
standardizedPersonVariances() - Method in class flanagan.analysis.Scores
 
standardizedRangeOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardizedRangeOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardizedRangeOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardizedRangeOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardizedRangeOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardizedRangeOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardizedRangeOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardizedRangeOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardizedScoresAsRowPerItem() - Method in class flanagan.analysis.Scores
 
standardizedScoresAsRowPerPerson() - Method in class flanagan.analysis.Scores
 
standardizedStanadarDeviationOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardizedStanadarDeviationOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardizedStanadarDeviationOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardizedStanadarDeviationOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardizedStanadarDeviationOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardizedStanadarDeviationOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardizedStanadarDeviationOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardizedStanadarDeviationOfItemVariances() - Method in class flanagan.analysis.Scores
 
standardizedStandardDeviationCorrelationCoefficients() - Method in class flanagan.analysis.Scores
 
standardizedStandardDeviationCorrelationCoefficientsWithTotals() - Method in class flanagan.analysis.Scores
 
standardizedTransformedData() - Method in class flanagan.analysis.BoxCox
 
standardizedVarianceOfItemMaxima() - Method in class flanagan.analysis.Scores
 
standardizedVarianceOfItemMeans() - Method in class flanagan.analysis.Scores
 
standardizedVarianceOfItemMedians() - Method in class flanagan.analysis.Scores
 
standardizedVarianceOfItemMinima() - Method in class flanagan.analysis.Scores
 
standardizedVarianceOfItemRanges() - Method in class flanagan.analysis.Scores
 
standardizedVarianceOfItemStandardDeviations() - Method in class flanagan.analysis.Scores
 
standardizedVarianceOfItemTotals() - Method in class flanagan.analysis.Scores
 
standardizedVarianceOfItemVariances() - Method in class flanagan.analysis.Scores
 
start() - Method in class cern.colt.Timer
Starts the timer.
start() - Method in class hep.aida.ref.fitter.fitdata.FitDataIterator
 
start() - Method in class hep.aida.ref.tuple.AbstractTuple
 
start() - Method in class hep.aida.ref.tuple.ChainedTuple
Positions the read cursor immediately before the first row.
start() - Method in interface hep.aida.ref.tuple.FTupleCursor
 
start() - Method in class hep.aida.ref.tuple.TupleCursor
 
start() - Method in class jhplot.bsom.Bsom
 
start() - Method in class jhplot.bsom.BsomDemo
 
start() - Method in class jhplot.v3d.Animation
 
start(int, int, int, int, int, int) - Method in class org.apache.commons.math.linear.DefaultFieldMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math.linear.DefaultFieldMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math.linear.DefaultRealMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in class org.apache.commons.math.linear.DefaultRealMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math.linear.FieldMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math.linear.FieldMatrixPreservingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math.linear.RealMatrixChangingVisitor
Start visiting a matrix.
start(int, int, int, int, int, int) - Method in interface org.apache.commons.math.linear.RealMatrixPreservingVisitor
Start visiting a matrix.
start() - Method in class org.apache.commons.math.util.ResizableDoubleArray
Returns the starting index of the internal array.
start() - Static method in class umontreal.iro.lecuyer.simevents.Sim
Starts the simulation executive.
start() - Method in class umontreal.iro.lecuyer.simevents.Simulator
Starts the simulation executive.
STARTING - Static variable in class umontreal.iro.lecuyer.simprocs.SimProcess
 
startInteg() - Method in class umontreal.iro.lecuyer.simevents.Continuous
Starts the integration process that will change the state of this variable at each integration step.
startInteg(double) - Method in class umontreal.iro.lecuyer.simevents.Continuous
Same as startInteg, after initializing the variable to val.
startNoThread() - Method in class jhplot.bsom.BsomDemo
 
startOfBin(int) - Method in class cern.jet.stat.quantile.EquiDepthHistogram
Returns the start of the range associated with the given bin.
startOfBin(int) - Method in class cern.jet.stat.tdouble.quantile.DoubleEquiDepthHistogram
Returns the start of the range associated with the given bin.
startOfBin(int) - Method in class cern.jet.stat.tfloat.quantile.FloatEquiDepthHistogram
Returns the start of the range associated with the given bin.
Stat - Class in flanagan.analysis
 
Stat() - Constructor for class flanagan.analysis.Stat
 
Stat(double[]) - Constructor for class flanagan.analysis.Stat
 
Stat(Double[]) - Constructor for class flanagan.analysis.Stat
 
Stat(float[]) - Constructor for class flanagan.analysis.Stat
 
Stat(Float[]) - Constructor for class flanagan.analysis.Stat
 
Stat(long[]) - Constructor for class flanagan.analysis.Stat
 
Stat(Long[]) - Constructor for class flanagan.analysis.Stat
 
Stat(int[]) - Constructor for class flanagan.analysis.Stat
 
Stat(Integer[]) - Constructor for class flanagan.analysis.Stat
 
Stat(short[]) - Constructor for class flanagan.analysis.Stat
 
Stat(Short[]) - Constructor for class flanagan.analysis.Stat
 
Stat(byte[]) - Constructor for class flanagan.analysis.Stat
 
Stat(Byte[]) - Constructor for class flanagan.analysis.Stat
 
Stat(BigDecimal[]) - Constructor for class flanagan.analysis.Stat
 
Stat(BigInteger[]) - Constructor for class flanagan.analysis.Stat
 
Stat(Complex[]) - Constructor for class flanagan.analysis.Stat
 
Stat(Phasor[]) - Constructor for class flanagan.analysis.Stat
 
Stat(String[]) - Constructor for class flanagan.analysis.Stat
 
Stat(Object[]) - Constructor for class flanagan.analysis.Stat
 
Stat(Vector<Object>) - Constructor for class flanagan.analysis.Stat
 
Stat(ArrayList<Object>) - Constructor for class flanagan.analysis.Stat
 
StatBox - Static variable in class jhplot.HPlotJa
 
StatConfidence - Class in jhpro.stat.limit
This is a class to give confidence intervals on various measurements calculated from the number of events observed, the acceptance factor, the background estimate and the associated errors.
StatConfidence(double, double, double, int) - Constructor for class jhpro.stat.limit.StatConfidence
Initialize the limit calculations
statCopy() - Method in class flanagan.math.ArrayMaths
 
state() - Method in class umontreal.iro.lecuyer.simprocs.Condition
Returns the state (true or false) of the condition.
stateChanged(EventObject) - Method in interface hep.aida.ref.event.AIDAListener
 
stateChanged(EventObject) - Method in class hep.aida.ref.event.ObserverAdapter
 
stateChanged(EventObject) - Method in class hep.aida.ref.histogram.DataPoint
 
stateChanged(EventObject) - Method in class hep.aida.ref.histogram.DataPointSet
 
stateChanged(EventObject) - Method in class hep.aida.ref.tree.MountPoint
 
StaticBin1D - Class in cern.hep.aida.bin
1-dimensional non-rebinnable bin consuming double elements; Efficiently computes basic statistics of data sequences.
StaticBin1D() - Constructor for class cern.hep.aida.bin.StaticBin1D
Constructs and returns an empty bin.
StaticDoubleBin1D - Class in hep.aida.tdouble.bin
1-dimensional non-rebinnable bin consuming double elements; Efficiently computes basic statistics of data sequences.
StaticDoubleBin1D() - Constructor for class hep.aida.tdouble.bin.StaticDoubleBin1D
Constructs and returns an empty bin.
StaticFloatBin1D - Class in hep.aida.tfloat.bin
1-dimensional non-rebinnable bin consuming float elements; Efficiently computes basic statistics of data sequences.
StaticFloatBin1D() - Constructor for class hep.aida.tfloat.bin.StaticFloatBin1D
Constructs and returns an empty bin.
staticNextBoolean() - Static method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random boolean.
staticNextBoolean() - Static method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random boolean.
staticNextBoolean() - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random boolean.
staticNextDouble(double, double) - Static method in class cern.jet.random.Beta
Returns a random number from the distribution.
staticNextDouble(double, double, double) - Static method in class cern.jet.random.BreitWigner
Returns a random number from the distribution.
staticNextDouble(double, double, double) - Static method in class cern.jet.random.BreitWignerMeanSquare
Returns a random number from the distribution.
staticNextDouble(double) - Static method in class cern.jet.random.ChiSquare
Returns a random number from the distribution.
staticNextDouble(double) - Static method in class cern.jet.random.Exponential
Returns a random number from the distribution with the given lambda.
staticNextDouble(double) - Static method in class cern.jet.random.ExponentialPower
Returns a random number from the distribution.
staticNextDouble(double, double) - Static method in class cern.jet.random.Gamma
Returns a random number from the distribution.
staticNextDouble(double, double) - Static method in class cern.jet.random.Hyperbolic
Returns a random number from the distribution.
staticNextDouble(double) - Static method in class cern.jet.random.Logarithmic
Returns a random number from the distribution.
staticNextDouble(double, double) - Static method in class cern.jet.random.Normal
Returns a random number from the distribution with the given mean and standard deviation.
staticNextDouble(double) - Static method in class cern.jet.random.StudentT
Returns a random number from the distribution.
staticNextDouble(double, double) - Static method in class cern.jet.random.tdouble.Beta
Returns a random number from the distribution.
staticNextDouble(double, double, double) - Static method in class cern.jet.random.tdouble.BreitWigner
Returns a random number from the distribution.
staticNextDouble(double, double, double) - Static method in class cern.jet.random.tdouble.BreitWignerMeanSquare
Returns a random number from the distribution.
staticNextDouble(double) - Static method in class cern.jet.random.tdouble.ChiSquare
Returns a random number from the distribution.
staticNextDouble() - Static method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the open interval (0,1) (excluding 0 and 1).
staticNextDouble(double) - Static method in class cern.jet.random.tdouble.Exponential
Returns a random number from the distribution with the given lambda.
staticNextDouble(double) - Static method in class cern.jet.random.tdouble.ExponentialPower
Returns a random number from the distribution.
staticNextDouble(double, double) - Static method in class cern.jet.random.tdouble.Gamma
Returns a random number from the distribution.
staticNextDouble(double, double) - Static method in class cern.jet.random.tdouble.Hyperbolic
Returns a random number from the distribution.
staticNextDouble(double) - Static method in class cern.jet.random.tdouble.Logarithmic
Returns a random number from the distribution.
staticNextDouble(double, double) - Static method in class cern.jet.random.tdouble.Normal
Returns a random number from the distribution with the given mean and standard deviation.
staticNextDouble(double) - Static method in class cern.jet.random.tdouble.StudentT
Returns a random number from the distribution.
staticNextDouble(double) - Static method in class cern.jet.random.tdouble.VonMises
Returns a random number from the distribution.
staticNextDouble() - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (0,1) (excluding 0 and 1).
staticNextDouble(double) - Static method in class cern.jet.random.VonMises
Returns a random number from the distribution.
staticNextDoubleFromTo(double, double) - Static method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
staticNextDoubleFromTo(double, double) - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
staticNextFloat() - Static method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random number in the open interval (0,1) (excluding 0 and 1).
staticNextFloatFromTo(float, float) - Static method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
staticNextFloatFromTo(float, float) - Static method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
staticNextFloatFromTo(float, float) - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the open interval (from,to) (excluding from and to).
staticNextInt(int, double) - Static method in class cern.jet.random.Binomial
Returns a random number from the distribution with the given parameters n and p.
staticNextInt(int, int, int) - Static method in class cern.jet.random.HyperGeometric
Returns a random number from the distribution.
staticNextInt(int, double) - Static method in class cern.jet.random.NegativeBinomial
Returns a random number from the distribution with the given parameters n and p.
staticNextInt(double) - Static method in class cern.jet.random.Poisson
Returns a random number from the distribution with the given mean.
staticNextInt(double) - Static method in class cern.jet.random.PoissonSlow
Returns a random number from the distribution with the given mean.
staticNextInt(int, double) - Static method in class cern.jet.random.tdouble.Binomial
Returns a random number from the distribution with the given parameters n and p.
staticNextInt(int, int, int) - Static method in class cern.jet.random.tdouble.HyperGeometric
Returns a random number from the distribution.
staticNextInt(int, double) - Static method in class cern.jet.random.tdouble.NegativeBinomial
Returns a random number from the distribution with the given parameters n and p.
staticNextInt(double) - Static method in class cern.jet.random.tdouble.Poisson
Returns a random number from the distribution with the given mean.
staticNextInt(double) - Static method in class cern.jet.random.tdouble.PoissonSlow
Returns a random number from the distribution with the given mean.
staticNextInt(double, double) - Static method in class cern.jet.random.tdouble.Zeta
Returns a random number from the distribution.
staticNextInt(double, double) - Static method in class cern.jet.random.Zeta
Returns a random number from the distribution.
staticNextIntFromTo(int, int) - Static method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
staticNextIntFromTo(int, int) - Static method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
staticNextIntFromTo(int, int) - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
staticNextLongFromTo(long, long) - Static method in class cern.jet.random.tdouble.DoubleUniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
staticNextLongFromTo(long, long) - Static method in class cern.jet.random.tfloat.FloatUniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
staticNextLongFromTo(long, long) - Static method in class cern.jet.random.Uniform
Returns a uniformly distributed random number in the closed interval [from,to] (including from and to).
staticSetRandomEngine(DoubleRandomEngine) - Static method in class cern.jet.random.tdouble.DoubleUniform
Sets the uniform random number generation engine shared by all static methods.
staticSetRandomEngine(FloatRandomEngine) - Static method in class cern.jet.random.tfloat.FloatUniform
Sets the uniform random number generation engine shared by all static methods.
staticSetRandomEngine(RandomEngine) - Static method in class cern.jet.random.Uniform
Sets the uniform random number generation engine shared by all static methods.
Statistic - Class in cern.colt.matrix.doublealgo
Basic statistics operations on matrices.
Statistic.VectorVectorFunction - Interface in cern.colt.matrix.doublealgo
Interface that represents a function object: a function that takes two argument vectors and returns a single value.
StatisticalMultivariateSummary - Interface in org.apache.commons.math.stat.descriptive
Reporting interface for basic multivariate statistics.
StatisticalSummary - Interface in org.apache.commons.math.stat.descriptive
Reporting interface for basic univariate statistics.
StatisticalSummaryValues - Class in org.apache.commons.math.stat.descriptive
Value object representing the results of a univariate statistical summary.
StatisticalSummaryValues(double, double, long, double, double, double) - Constructor for class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
Constructor
Statistics - Class in jhplot.stat
A static class for statistical calculations
Statistics() - Constructor for class jhplot.stat.Statistics
 
StatisticSample - Class in jhplot.math
A package to create random 1D and 2D arrays.
StatisticSample() - Constructor for class jhplot.math.StatisticSample
 
statOnAvail() - Method in class umontreal.iro.lecuyer.simprocs.Bin
Returns the statistical collector for the available tokens on the bin as a function of time.
statOnCapacity() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Returns the statistical collector that measures the evolution of the capacity of the resource as a function of time.
statOnSojourn() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Returns the statistical collector for the sojourn times of the UserRecord for this resource.
statOnUtil() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Returns the statistical collector for the utilization of the resource (number of units busy) as a function of time.
StatProbe - Class in umontreal.iro.lecuyer.stat
The objects of this class are statistical probes or collectors, which are elementary devices for collecting statistics.
StatProbe() - Constructor for class umontreal.iro.lecuyer.stat.StatProbe
 
stats() - Method in class cern.colt.matrix.linalg.SmpBlas
Prints various snapshot statistics to System.out; Simply delegates to FJTaskRunnerGroup.stats().
StatShape - Class in jhplot.stat
Shape identification based on a linear regression It calculates eccentricities in the transverse and longitudinal directions, as well as the size of the objects.
StatShape(double[], double[], double[], int) - Constructor for class jhplot.stat.StatShape
Perform a linear regression analysis with weights and prepare for a shape identification.
statSize() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
Returns the statistical probe on the evolution of the size of the list as a function of the simulation time.
statSojourn() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat
Returns the statistical probe on the sojourn times of the objects in the list.
statusbar - Static variable in class jhplot.JHPlot
 
StatUtils - Class in org.apache.commons.math.stat
StatUtils provides static methods for computing statistics based on data stored in double[] arrays.
stbcon(String, String, String, int, int, float[], int, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
stbmv(String, String, String, int, int, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
stbrfs(String, String, String, int, int, int, float[], int, float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
stbsv(String, String, String, int, int, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
stbtrs(String, String, String, int, int, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
stdDev - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.standardDeviation().
stdDev - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.standardDeviation().
stdDev - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.standardDeviation().
stddeviation(double[]) - Static method in class jhplot.math.StatisticSample
Standard deviation
stddeviation(double[][]) - Static method in class jhplot.math.StatisticSample
Standard deviation
stddeviation() - Method in class jhplot.P0D
Returns the standard deviation (square root of variance)
stddeviation() - Method in class jhplot.P0I
Returns the standard deviation (square root of variance)
stddeviation(double[]) - Static method in class jhplot.stat.Statistics
Standard deviation
stddeviation(double[][]) - Static method in class jhplot.stat.Statistics
Standard deviation
stddeviationX() - Method in class jhplot.P1D
Standard deviation of values X.
stddeviationY() - Method in class jhplot.P1D
Standard deviation of values Y.
Stencil - Class in cern.colt.matrix.doublealgo
Stencil operations.
stencil27(DoubleMatrix3D, Double27Function, int, DoubleMatrix3DProcedure, int) - Static method in class cern.colt.matrix.doublealgo.Stencil
27 point stencil operation.
stencil27(DoubleMatrix3D, Double27Function, int, DoubleMatrix3DProcedure, int) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStencil
27 point stencil operation.
stencil27(FloatMatrix3D, Float27Function, int, FloatMatrix3DProcedure, int) - Static method in class cern.colt.matrix.tfloat.algo.FloatStencil
27 point stencil operation.
stencil9(DoubleMatrix2D, Double9Function, int, DoubleMatrix2DProcedure, int) - Static method in class cern.colt.matrix.doublealgo.Stencil
9 point stencil operation.
stencil9(DoubleMatrix2D, Double9Function, int, DoubleMatrix2DProcedure, int) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStencil
9 point stencil operation.
stencil9(FloatMatrix2D, Float9Function, int, FloatMatrix2DProcedure, int) - Static method in class cern.colt.matrix.tfloat.algo.FloatStencil
9 point stencil operation.
stepAccepted(double, double[]) - Method in class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Inform the event handlers that the step has been accepted by the integrator.
stepAccepted(double, double[]) - Method in class org.apache.commons.math.ode.events.EventState
Acknowledge the fact the step has been accepted by the integrator.
stepFunction() - Method in class flanagan.analysis.Regression
 
stepFunctionPlot() - Method in class flanagan.analysis.Regression
 
StepHandler - Interface in org.apache.commons.math.ode.sampling
This interface represents a handler that should be called after each successful step.
StepHandlerWithJacobians - Interface in org.apache.commons.math.ode.jacobians
Deprecated. as of 2.2 the complete package is deprecated, it will be replaced in 3.0 by a completely rewritten implementation
StepInterpolator - Interface in org.apache.commons.math.ode.sampling
This interface represents an interpolator over the last step during an ODE integration.
StepInterpolatorWithJacobians - Interface in org.apache.commons.math.ode.jacobians
Deprecated. as of 2.2 the complete package is deprecated, it will be replaced in 3.0 by a completely rewritten implementation
StepNormalizer - Class in org.apache.commons.math.ode.sampling
This class wraps an object implementing FixedStepHandler into a StepHandler.
StepNormalizer(double, FixedStepHandler) - Constructor for class org.apache.commons.math.ode.sampling.StepNormalizer
Simple constructor.
stepSize() - Method in class hep.aida.ref.fitter.FitParameterSettings
 
steradian - Static variable in class cern.clhep.Units
 
stgevc(String, String, boolean[], int, float[], int, float[], int, float[], int, float[], int, int, intW, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
stgex2(boolean, boolean, int, float[], int, float[], int, float[], int, float[], int, int, int, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
stgexc(boolean, boolean, int, float[], int, float[], int, float[], int, float[], int, intW, intW, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
stgsen(int, boolean, boolean, boolean[], int, float[], int, float[], int, float[], float[], float[], float[], int, float[], int, intW, floatW, floatW, float[], float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
stgsja(String, String, String, int, int, int, int, int, float[], int, float[], int, float, float, float[], float[], float[], int, float[], int, float[], int, float[], intW, intW) - Method in class org.netlib.lapack.LAPACK
..
stgsna(String, String, boolean[], int, float[], int, float[], int, float[], int, float[], int, float[], float[], int, intW, float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
stgsy2(String, int, int, int, float[], int, float[], int, float[], int, float[], int, float[], int, float[], int, floatW, floatW, floatW, int[], intW, intW) - Method in class org.netlib.lapack.LAPACK
..
stgsyl(String, int, int, int, float[], int, float[], int, float[], int, float[], int, float[], int, float[], int, floatW, floatW, float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
stirlingCorrection(int) - Static method in class cern.jet.math.Arithmetic
Returns the StirlingCorrection.
stirlingCorrection(int) - Static method in class cern.jet.math.tdouble.DoubleArithmetic
Returns the StirlingCorrection.
stirlingCorrection(int) - Static method in class cern.jet.math.tfloat.FloatArithmetic
Returns the StirlingCorrection.
StochasticProcess - Class in umontreal.iro.lecuyer.stochprocess
Abstract base class for a stochastic process {X(t) : t >= 0} sampled (or observed) at a finite number of time points, 0 = t0 < t1 < ...
StochasticProcess() - Constructor for class umontreal.iro.lecuyer.stochprocess.StochasticProcess
 
stop() - Method in class cern.colt.Timer
Stops the timer.
stop() - Method in class jhplot.bsom.Bsom
 
stop() - Method in class jhplot.bsom.BsomDemo
 
stop() - Method in class jhplot.v3d.Animation
 
stop() - Method in class org.apache.commons.math.ode.events.CombinedEventsManager
Deprecated. Check if the integration should be stopped at the end of the current step.
STOP - Static variable in interface org.apache.commons.math.ode.events.EventHandler
Stop indicator.
stop() - Method in class org.apache.commons.math.ode.events.EventState
Check if the integration should be stopped at the end of the current step.
STOP - Static variable in interface org.apache.commons.math.ode.jacobians.EventHandlerWithJacobians
Deprecated. Stop indicator.
stop() - Static method in class umontreal.iro.lecuyer.simevents.Sim
Tells the simulation executive to stop as soon as it takes control, and to return control to the program that called start.
stop() - Method in class umontreal.iro.lecuyer.simevents.Simulator
Tells the simulation executive to stop as soon as it takes control, and to return control to the program that called start.
stopInteg() - Method in class umontreal.iro.lecuyer.simevents.Continuous
Stops the integration process for this continuous variable.
StoppingCondition - Interface in org.apache.commons.math.genetics
Algorithm used to determine when to stop evolution.
storeAll(String) - Method in class hep.aida.ref.function.FunctionCatalog
 
StorelessUnivariateStatistic - Interface in org.apache.commons.math.stat.descriptive
Extends the definition of UnivariateStatistic with StorelessUnivariateStatistic.increment(double) and StorelessUnivariateStatistic.incrementAll(double[]) methods for adding values and updating internal state.
storeName() - Method in class hep.aida.ref.tree.Tree
Get the name of the store.
storeTime(double) - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
Store the current step time.
storeType() - Method in class hep.aida.ref.tree.Tree
 
STP_Pressure - Static variable in class cern.clhep.PhysicalConstants
 
STP_Temperature - Static variable in class cern.clhep.PhysicalConstants
 
stpcon(String, String, String, int, float[], floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
stpmv(String, String, String, int, float[], float[], int) - Method in class org.netlib.blas.BLAS
..
stprfs(String, String, String, int, int, float[], float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
stpsv(String, String, String, int, float[], float[], int) - Method in class org.netlib.blas.BLAS
..
stptri(String, String, int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
stptrs(String, String, String, int, int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
strcon(String, String, String, int, float[], int, floatW, float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
strevc(String, String, boolean[], int, float[], int, float[], int, float[], int, int, intW, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
strexc(String, int, float[], int, float[], int, intW, intW, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
stride() - Method in class cern.colt.matrix.AbstractMatrix1D
Returns the stride.
StringPrintable - Interface in jhplot.math.io
BSD License
stringToArray(String) - Static method in class hep.aida.ref.AidaUtils
 
stripedMatrixScramble(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Applies the striped matrix scramble proposed by Owen.
stripedMatrixScramble(RandomStream) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
stripedMatrixScrambleFaurePermutAll(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNet
Similar to stripedMatrixScramble except that the elements on and under the diagonal of each matrix Mj are chosen as in leftMatrixScrambleFaurePermut.
stripedMatrixScrambleFaurePermutAll(RandomStream, int) - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
strmm(String, String, String, String, int, int, float, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
strmv(String, String, String, int, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
strrfs(String, String, String, int, int, float[], int, float[], int, float[], int, float[], float[], float[], int[], intW) - Method in class org.netlib.lapack.LAPACK
..
strsen(String, String, boolean[], int, float[], int, float[], int, float[], float[], intW, floatW, floatW, float[], int, int[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
strsm(String, String, String, String, int, int, float, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
strsna(String, String, boolean[], int, float[], int, float[], int, float[], int, float[], float[], int, intW, float[], int, int[], intW) - Method in class org.netlib.lapack.LAPACK
..
strsv(String, String, String, int, float[], int, float[], int) - Method in class org.netlib.blas.BLAS
..
strsyl(String, String, int, int, int, float[], int, float[], int, float[], int, floatW, intW) - Method in class org.netlib.lapack.LAPACK
..
strti2(String, String, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
strtri(String, String, int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
strtrs(String, String, String, int, int, float[], int, float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
StudentDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Student t-distribution with n degrees of freedom, where n is a positive integer.
StudentDist(int) - Constructor for class umontreal.iro.lecuyer.probdist.StudentDist
Constructs a StudentDist object with n degrees of freedom.
StudentDistQuick - Class in umontreal.iro.lecuyer.probdist
Extends the class StudentDist for the Student t-distribution.
StudentDistQuick(int) - Constructor for class umontreal.iro.lecuyer.probdist.StudentDistQuick
Constructs a StudentDistQuick object with n degrees of freedom.
StudentGen - Class in umontreal.iro.lecuyer.randvar
This class implements methods for generating random variates from the Student distribution with n > 0 degrees of freedom.
StudentGen(RandomStream, int) - Constructor for class umontreal.iro.lecuyer.randvar.StudentGen
Creates a Student random variate generator with n degrees of freedom, using stream s.
StudentGen(RandomStream, StudentDist) - Constructor for class umontreal.iro.lecuyer.randvar.StudentGen
Creates a new generator for the Student distribution dist and stream s.
StudentPolarGen - Class in umontreal.iro.lecuyer.randvar
This class implements Student random variate generators using the polar method of.
StudentPolarGen(RandomStream, int) - Constructor for class umontreal.iro.lecuyer.randvar.StudentPolarGen
Creates a Student random variate generator with n degrees of freedom, using stream s.
StudentPolarGen(RandomStream, StudentDist) - Constructor for class umontreal.iro.lecuyer.randvar.StudentPolarGen
Creates a new generator for the Student distribution dist and stream s.
studentst(double, int) - Static method in class flanagan.analysis.Stat
 
studentstCDF(double, int) - Static method in class flanagan.analysis.Stat
 
studentstMean(int) - Static method in class flanagan.analysis.Stat
 
studentstMedian() - Static method in class flanagan.analysis.Stat
 
studentstMode() - Static method in class flanagan.analysis.Stat
 
studentstPDF(double, int) - Static method in class flanagan.analysis.Stat
 
studentstRand(int, int) - Static method in class flanagan.analysis.Stat
 
studentstRand(int, int, long) - Static method in class flanagan.analysis.Stat
 
studentstStandardDeviation(int) - Static method in class flanagan.analysis.Stat
 
StudentT - Class in cern.jet.random
StudentT distribution (aka T-distribution); See the math definition and animated definition.
StudentT(double, RandomEngine) - Constructor for class cern.jet.random.StudentT
Constructs a StudentT distribution.
StudentT - Class in cern.jet.random.tdouble
StudentT distribution (aka T-distribution); See the math definition and animated definition.
StudentT(double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.StudentT
Constructs a StudentT distribution.
studentT(double, double) - Static method in class cern.jet.stat.Probability
Returns the integral from minus infinity to t of the Student-t distribution with k > 0 degrees of freedom.
studentT(double, double) - Static method in class cern.jet.stat.tdouble.Probability
Returns the integral from minus infinity to t of the Student-t distribution with k > 0 degrees of freedom.
studentT(double, int) - Static method in class flanagan.analysis.Stat
 
studentTarray(int, int) - Method in class flanagan.math.PsRandom
 
studentTcdf(double, int) - Static method in class flanagan.analysis.Stat
 
studentTCDF(double, int) - Static method in class flanagan.analysis.Stat
 
studentTcdf(double, double, int) - Static method in class flanagan.analysis.Stat
 
studentTInverse(double, int) - Static method in class cern.jet.stat.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 1-alpha/2.
studentTInverse(double, int) - Static method in class cern.jet.stat.tdouble.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 1-alpha/2.
studentTmean(int) - Static method in class flanagan.analysis.Stat
 
studentTmedian() - Static method in class flanagan.analysis.Stat
 
studentTmode() - Static method in class flanagan.analysis.Stat
 
studentTpdf(double, int) - Static method in class flanagan.analysis.Stat
 
studentTPDF(double, int) - Static method in class flanagan.analysis.Stat
 
studentTProb(double, int) - Static method in class flanagan.analysis.Stat
 
studentTRand(int, int) - Static method in class flanagan.analysis.Stat
 
studentTrand(int, int) - Static method in class flanagan.analysis.Stat
 
studentTrand(int, int, long) - Static method in class flanagan.analysis.Stat
 
studentTRand(int, int, long) - Static method in class flanagan.analysis.Stat
 
studentTstandDev(int) - Static method in class flanagan.analysis.Stat
 
stzrqf(int, int, float[], int, float[], intW) - Method in class org.netlib.lapack.LAPACK
..
stzrzf(int, int, float[], int, float[], float[], int, intW) - Method in class org.netlib.lapack.LAPACK
..
sub(Binner1D, Binner1D, Binner1D) - Static method in class hep.aida.ref.histogram.binner.BinnerMath
 
sub(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Subtract
sub(Hep3Vector, Hep3Vector) - Method in class hephysics.vec.Hep3Vector
Subtract
sub(HepLorentzVector, HepLorentzVector) - Method in class hephysics.vec.HepLorentzVector
Subtract 2 vectors
sub(Hep3Vector, Hep3Vector) - Static method in class hephysics.vec.VecOp
 
sub(Vector3d) - Method in class jhplot.v3d.Vector3d
 
subAndCheck(int, int) - Static method in class org.apache.commons.math.util.MathUtils
Subtract two integers, checking for overflow.
subAndCheck(long, long) - Static method in class org.apache.commons.math.util.MathUtils
Subtract two long integers, checking for overflow.
subarray_as_ArrayList(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_BigDecimal(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_BigInteger(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_byte(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Byte(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_char(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Character(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Complex(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Complex_columnMatrix(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Complex_rowMatrix(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_degrees_phase_of_Phasor(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_double(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Double(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Float(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_float(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_imaginay_part_of_Complex(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_int(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Integer(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_long(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Long(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_magnitude_of_Phasor(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Matrix_columnMatrix(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Matrix_rowMatrix(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_modulus_of_Complex(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Object(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Phasor(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Phasor_columnMatrix(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Phasor_rowMatrix(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_radians_phase_of_Phasor(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_real_part_of_Complex(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_short(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Short(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_String(int, int) - Method in class flanagan.math.ArrayMaths
 
subarray_as_Vector(int, int) - Method in class flanagan.math.ArrayMaths
 
subList(int, int) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
subMatrix(DoubleMatrix2D, int, int, int, int) - Method in class cern.colt.matrix.linalg.Algebra
Constructs and returns a new sub-range view which is the sub matrix A[fromRow..toRow,fromColumn..toColumn].
subMatrix(DoubleMatrix2D, int[], int, int) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Copies the columns of the indicated rows into a new sub matrix.
subMatrix(DoubleMatrix2D, int, int, int[]) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Copies the rows of the indicated columns into a new sub matrix.
subMatrix(DoubleMatrix2D, int, int, int, int) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Constructs and returns a new sub-range view which is the sub matrix A[fromRow..toRow,fromColumn..toColumn].
subMatrix(FloatMatrix2D, int[], int, int) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Copies the columns of the indicated rows into a new sub matrix.
subMatrix(FloatMatrix2D, int, int, int[]) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Copies the rows of the indicated columns into a new sub matrix.
subMatrix(FloatMatrix2D, int, int, int, int) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Constructs and returns a new sub-range view which is the sub matrix A[fromRow..toRow,fromColumn..toColumn].
subSequence(int, int) - Method in class umontreal.iro.lecuyer.util.PrintfFormat
 
SubsetOfPointSet - Class in umontreal.iro.lecuyer.hups
This container class permits one to select a subset of a point set.
SubsetOfPointSet(PointSet) - Constructor for class umontreal.iro.lecuyer.hups.SubsetOfPointSet
Constructs a new PointSet object, initially identical to P, and from which a subset of the points and/or a subset of the coordinates is to be extracted.
substituteMostRecentElement(double) - Method in class org.apache.commons.math.util.ResizableDoubleArray
Substitutes value for the most recently added value.
substituteText(String, String, String) - Static method in class jhplot.v3d.Util
Renders a string based on text where any occurence of token is replaced by substitute.
substituteTextS(String, String, String) - Static method in class jhplot.v3d.Util
Renders a string based on text where any occurence of token is replaced by substitute.
subtract(String, IDataPointSet, IDataPointSet) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
subtract(String, IHistogram1D, IHistogram1D) - Method in class hep.aida.ref.histogram.HistogramFactory
Subtracts two 1D Histogram
subtract(String, IHistogram2D, IHistogram2D) - Method in class hep.aida.ref.histogram.HistogramFactory
Subtracts two 2D Histogram
subtract(String, IHistogram3D, IHistogram3D) - Method in class hep.aida.ref.histogram.HistogramFactory
Subtracts two 3D Histogram
subtract(double[], double[]) - Static method in class jhplot.math.ArrayMathUtils
Subtracts the two arrays together (componentwise)
subtract(int[], int[]) - Static method in class jhplot.math.ArrayMathUtils
Subtracts the two arrays together (componentwise).
SUBTRACT - Static variable in class org.apache.commons.math.analysis.BinaryFunction
Deprecated. The - operator method wrapped as a BinaryFunction.
subtract(UnivariateRealFunction) - Method in class org.apache.commons.math.analysis.ComposableFunction
Return a function subtracting another function from the instance.
subtract(PolynomialFunction) - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Subtract a polynomial from the instance.
subtract(Complex) - Method in class org.apache.commons.math.complex.Complex
Return the difference between this complex number and the given complex number.
subtract(Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Subtract x from this.
subtract(T) - Method in interface org.apache.commons.math.FieldElement
Compute this - a.
subtract(BigInteger) - Method in class org.apache.commons.math.fraction.BigFraction
Subtracts the value of an BigInteger from the value of this one, returning the result in reduced form.
subtract(int) - Method in class org.apache.commons.math.fraction.BigFraction
Subtracts the value of an integer from the value of this one, returning the result in reduced form.
subtract(long) - Method in class org.apache.commons.math.fraction.BigFraction
Subtracts the value of an integer from the value of this one, returning the result in reduced form.
subtract(BigFraction) - Method in class org.apache.commons.math.fraction.BigFraction
Subtracts the value of another fraction from the value of this one, returning the result in reduced form.
subtract(Fraction) - Method in class org.apache.commons.math.fraction.Fraction
Subtracts the value of another fraction from the value of this one, returning the result in reduced form.
subtract(int) - Method in class org.apache.commons.math.fraction.Fraction
Subtract an integer from the fraction.
subtract(Vector3D) - Method in class org.apache.commons.math.geometry.Vector3D
Subtract a vector from the instance.
subtract(double, Vector3D) - Method in class org.apache.commons.math.geometry.Vector3D
Subtract a scaled vector from the instance.
subtract(FieldMatrix<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Compute this minus m.
subtract(RealMatrix) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Compute this minus m.
subtract(double[]) - Method in class org.apache.commons.math.linear.AbstractRealVector
Subtract v from this vector.
subtract(RealVector) - Method in class org.apache.commons.math.linear.AbstractRealVector
Subtract v from this vector.
subtract(FieldMatrix<T>) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Compute this minus m.
subtract(Array2DRowFieldMatrix<T>) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Compute this minus m.
subtract(RealMatrix) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Compute this minus m.
subtract(Array2DRowRealMatrix) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Compute this minus m.
subtract(FieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute this minus v.
subtract(T[]) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute this minus v.
subtract(ArrayFieldVector<T>) - Method in class org.apache.commons.math.linear.ArrayFieldVector
Compute this minus v.
subtract(RealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Subtract v from this vector.
subtract(double[]) - Method in class org.apache.commons.math.linear.ArrayRealVector
Subtract v from this vector.
subtract(ArrayRealVector) - Method in class org.apache.commons.math.linear.ArrayRealVector
Compute this minus v.
subtract(BigMatrix) - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Compute this minus m.
subtract(BigMatrix) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Compute this minus m.
subtract(BigMatrixImpl) - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Compute this minus m.
subtract(FieldMatrix<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Compute this minus m.
subtract(BlockFieldMatrix<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Compute this minus m.
subtract(RealMatrix) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Compute this minus m.
subtract(BlockRealMatrix) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Compute this minus m.
subtract(FieldMatrix<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Compute this minus m.
subtract(FieldVector<T>) - Method in interface org.apache.commons.math.linear.FieldVector
Compute this minus v.
subtract(T[]) - Method in interface org.apache.commons.math.linear.FieldVector
Compute this minus v.
subtract(RealMatrix) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Compute this minus m.
subtract(OpenMapRealMatrix) - Method in class org.apache.commons.math.linear.OpenMapRealMatrix
Compute this minus m.
subtract(OpenMapRealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Optimized method to subtract OpenMapRealVectors.
subtract(RealVector) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Subtract v from this vector.
subtract(double[]) - Method in class org.apache.commons.math.linear.OpenMapRealVector
Subtract v from this vector.
subtract(RealMatrix) - Method in interface org.apache.commons.math.linear.RealMatrix
Compute this minus m.
subtract(RealMatrix) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Compute this minus m.
subtract(RealMatrixImpl) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Compute this minus m.
subtract(RealVector) - Method in interface org.apache.commons.math.linear.RealVector
Subtract v from this vector.
subtract(double[]) - Method in interface org.apache.commons.math.linear.RealVector
Subtract v from this vector.
subtract(SparseFieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Optimized method to subtract SparseRealVectors.
subtract(FieldVector<T>) - Method in class org.apache.commons.math.linear.SparseFieldVector
Compute this minus v.
subtract(T[]) - Method in class org.apache.commons.math.linear.SparseFieldVector
Compute this minus v.
subtract(BigReal) - Method in class org.apache.commons.math.util.BigReal
Compute this - a.
subtractColumnMeans() - Method in class flanagan.math.Matrix
 
subtractMean() - Method in class flanagan.analysis.Stat
 
subtractMean(double[]) - Static method in class flanagan.analysis.Stat
 
subtractMean(float[]) - Static method in class flanagan.analysis.Stat
 
subtractMean(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
subtractMean(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
subtractMean(Complex[]) - Static method in class flanagan.analysis.Stat
 
subtractMean(double[], double[]) - Static method in class flanagan.analysis.Stat
 
subtractMean(float[], float[]) - Static method in class flanagan.analysis.Stat
 
subtractMean(BigDecimal[], BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
subtractMean(BigInteger[], BigInteger[]) - Static method in class flanagan.analysis.Stat
 
subtractMean(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
subtractMean() - Method in class flanagan.math.Matrix
 
subtractMean_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
subtractMean_as_Complex() - Method in class flanagan.analysis.Stat
 
subtractMean_as_double() - Method in class flanagan.analysis.Stat
 
subtractRowMeans() - Method in class flanagan.math.Matrix
 
subtractWeightedMean() - Method in class flanagan.analysis.Stat
 
subtractWeightedMean_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
subtractWeightedMean_as_Complex() - Method in class flanagan.analysis.Stat
 
subtractWeightedMean_as_double() - Method in class flanagan.analysis.Stat
 
sum() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.sum().
sum() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum() - Method in class cern.hep.aida.bin.StaticBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the sum of a data sequence.
sum(DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sum of a data sequence.
sum(FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sum of a data sequence.
sum() - Method in class flanagan.math.ArrayMaths
 
sum() - Method in class flanagan.math.Matrix
 
sum() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.sum().
sum() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum() - Method in class hep.aida.tdouble.bin.StaticDoubleBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.sum().
sum() - Method in class hep.aida.tfloat.bin.StaticFloatBin1D
Returns the sum of all elements, which is Sum( x[i] ).
sum(double[]) - Static method in class jhplot.math.DoubleArray
Calculate the sum of the values in an array
sum(double[][]) - Static method in class jhplot.math.DoubleArray
Calculates the sum of each column in a matrix.
Sum - Class in org.apache.commons.math.stat.descriptive.summary
Returns the sum of the available values.
Sum() - Constructor for class org.apache.commons.math.stat.descriptive.summary.Sum
Create a Sum instance
Sum(Sum) - Constructor for class org.apache.commons.math.stat.descriptive.summary.Sum
Copy constructor, creates a new Sum identical to the original
sum(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the values in the input array, or Double.NaN if the array is empty.
sum(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
sum() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
 
sum(double[]) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
For each probe in the list, computes the sum by calling sum, and stores the results into the array s.
sum() - Method in class umontreal.iro.lecuyer.stat.StatProbe
Returns the sum cumulated so far for this probe.
sum_as_BigDecimal() - Method in class flanagan.math.ArrayMaths
 
sum_as_BigInteger() - Method in class flanagan.math.ArrayMaths
 
sum_as_byte() - Method in class flanagan.math.ArrayMaths
 
sum_as_Byte() - Method in class flanagan.math.ArrayMaths
 
sum_as_Complex() - Method in class flanagan.math.ArrayMaths
 
sum_as_double() - Method in class flanagan.math.ArrayMaths
 
sum_as_Double() - Method in class flanagan.math.ArrayMaths
 
sum_as_float() - Method in class flanagan.math.ArrayMaths
 
sum_as_Float() - Method in class flanagan.math.ArrayMaths
 
sum_as_int() - Method in class flanagan.math.ArrayMaths
 
sum_as_Integer() - Method in class flanagan.math.ArrayMaths
 
sum_as_long() - Method in class flanagan.math.ArrayMaths
 
sum_as_Long() - Method in class flanagan.math.ArrayMaths
 
sum_as_Phasor() - Method in class flanagan.math.ArrayMaths
 
sum_as_short() - Method in class flanagan.math.ArrayMaths
 
sum_as_Short() - Method in class flanagan.math.ArrayMaths
 
sum_as_String() - Method in class flanagan.math.ArrayMaths
 
sumAllBinHeights() - Method in class cern.hep.aida.ref.Histogram2D
 
sumAllBinHeights() - Method in class cern.hep.aida.ref.Histogram3D
 
sumAllBinHeights() - Method in class hep.aida.ref.histogram.Histogram
Get the sum of the bin heights for all the entries, in-range and out-range ones.
sumAllBinHeights() - Method in class hep.aida.ref.histogram.Histogram1D
Get the sum of the bin heights for all the entries, in-range and out-range ones.
sumAllBinHeights() - Method in class hep.aida.ref.histogram.Histogram2D
Get the sum of the bin heights for all the entries, in-range and out-range ones.
sumAllBinHeights() - Method in class hep.aida.ref.histogram.Histogram3D
Get the sum of the bin heights for all the entries, in-range and out-range ones.
sumAllBinHeights() - Method in class hep.aida.ref.histogram.Profile1D
 
sumAllBinHeights() - Method in class hep.aida.ref.histogram.Profile2D
 
sumAllBinHeights() - Method in interface hep.aida.tdouble.DoubleIHistogram
Sum of all (both in-range and under/overflow) bin heights in the histogram.
sumAllBinHeights() - Method in class hep.aida.tdouble.ref.DoubleHistogram2D
 
sumAllBinHeights() - Method in class hep.aida.tdouble.ref.DoubleHistogram3D
 
sumAllBinHeights() - Method in interface hep.aida.tfloat.FloatIHistogram
Sum of all (both in-range and under/overflow) bin heights in the histogram.
sumAllBinHeights() - Method in class hep.aida.tfloat.ref.FloatHistogram2D
 
sumAllBinHeights() - Method in class hep.aida.tfloat.ref.FloatHistogram3D
 
sumAllBinHeights() - Method in class jhplot.H1D
Sum of all heights
sumAllBinHeights() - Method in class jhplot.H2D
Get the sum of the bin heights for all the entries, in-range and out-range ones.
sumAllBinHeights() - Method in class jhplot.HProf1D
Sum of all heights
sumAllBinHeights() - Method in class jhplot.HProf2D
Get the sum of the bin heights for all the entries, in-range and out-range ones.
sumBinHeights() - Method in class hep.aida.ref.histogram.Histogram
Get the sum of the bin heights for in-range entries.
sumBinHeights() - Method in class hep.aida.ref.histogram.Profile1D
 
sumBinHeights() - Method in class hep.aida.ref.histogram.Profile2D
 
sumBinHeights() - Method in interface hep.aida.tdouble.DoubleIHistogram
Sum of in-range bin heights in the histogram.
sumBinHeights() - Method in interface hep.aida.tfloat.FloatIHistogram
Sum of in-range bin heights in the histogram.
sumDifference(double[], double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the (signed) differences between corresponding elements of the input arrays -- i.e., sum(sample1[i] - sample2[i]).
sumEntries() - Method in class jhplot.bsom.Matrix
Summation of all entries.
sumExtraBinHeights() - Method in class hep.aida.ref.histogram.Histogram
Get the sum of the bin heights for all the entries outside the Histogram's range.
sumExtraBinHeights() - Method in class hep.aida.ref.histogram.Histogram1D
Get the sum of the bin heights for all the entries outside the Histogram's range.
sumExtraBinHeights() - Method in class hep.aida.ref.histogram.Histogram2D
Get the sum of the bin heights for all the entries outside the Histogram's range.
sumExtraBinHeights() - Method in class hep.aida.ref.histogram.Histogram3D
Get the sum of the bin heights for all the entries outside the Histogram's range.
sumExtraBinHeights() - Method in class hep.aida.ref.histogram.Profile1D
 
sumExtraBinHeights() - Method in class hep.aida.ref.histogram.Profile2D
 
sumExtraBinHeights() - Method in interface hep.aida.tdouble.DoubleIHistogram
Sum of under/overflow bin heights in the histogram.
sumExtraBinHeights() - Method in interface hep.aida.tfloat.FloatIHistogram
Sum of under/overflow bin heights in the histogram.
sumExtraBinHeights() - Method in class jhplot.H2D
Get the sum of the bin heights for all the entries outside the Histogram's range.
sumExtraBinHeights() - Method in class jhplot.HProf2D
Get the sum of the bin heights for all the entries outside the Histogram's range.
sumLog - Static variable in class cern.hep.aida.bin.BinFunctions1D
Function that returns bin.sumOfLogarithms().
sumLog - Static variable in class hep.aida.tdouble.bin.DoubleBinFunctions1D
Function that returns bin.sumOfLogarithms().
sumLog - Static variable in class hep.aida.tfloat.bin.FloatBinFunctions1D
Function that returns bin.sumOfLogarithms().
sumLog(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the natural logs of the entries in the input array, or Double.NaN if the array is empty.
sumLog(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the natural logs of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
SummaryStatistics - Class in org.apache.commons.math.stat.descriptive
Computes summary statistics for a stream of data values added using the addValue method.
SummaryStatistics() - Constructor for class org.apache.commons.math.stat.descriptive.SummaryStatistics
Construct a SummaryStatistics instance
SummaryStatistics(SummaryStatistics) - Constructor for class org.apache.commons.math.stat.descriptive.SummaryStatistics
A copy constructor.
SumOfFunctions - Class in hep.aida.ref.function
 
SumOfFunctions(String, ArrayList) - Constructor for class hep.aida.ref.function.SumOfFunctions
 
sumOfInversions() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the sum of inversions, which is Sum( 1 / x[i] ).
sumOfInversions() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the sum of inversions, which is Sum( 1 / x[i] ).
sumOfInversions(DoubleArrayList, int, int) - Static method in class cern.jet.stat.Descriptive
Returns the sum of inversions of a data sequence, which is Sum( 1.0 / data[i]).
sumOfInversions(DoubleArrayList, int, int) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sum of inversions of a data sequence, which is Sum( 1.0 / data[i]).
sumOfInversions(FloatArrayList, int, int) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sum of inversions of a data sequence, which is Sum( 1.0 / data[i]).
sumOfInversions() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the sum of inversions, which is Sum( 1 / x[i] ).
sumOfInversions() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the sum of inversions, which is Sum( 1 / x[i] ).
sumOfInversions() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the sum of inversions, which is Sum( 1 / x[i] ).
sumOfInversions() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the sum of inversions, which is Sum( 1 / x[i] ).
sumOfLogarithms() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the sum of logarithms, which is Sum( Log(x[i]) ).
sumOfLogarithms() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the sum of logarithms, which is Sum( Log(x[i]) ).
sumOfLogarithms(DoubleArrayList, int, int) - Static method in class cern.jet.stat.Descriptive
Returns the sum of logarithms of a data sequence, which is Sum( Log(data[i]).
sumOfLogarithms(DoubleArrayList, int, int) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sum of logarithms of a data sequence, which is Sum( Log(data[i]).
sumOfLogarithms(FloatArrayList, int, int) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sum of logarithms of a data sequence, which is Sum( Log(data[i]).
sumOfLogarithms() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the sum of logarithms, which is Sum( Log(x[i]) ).
sumOfLogarithms() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the sum of logarithms, which is Sum( Log(x[i]) ).
sumOfLogarithms() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the sum of logarithms, which is Sum( Log(x[i]) ).
sumOfLogarithms() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the sum of logarithms, which is Sum( Log(x[i]) ).
SumOfLogs - Class in org.apache.commons.math.stat.descriptive.summary
Returns the sum of the natural logs for this collection of values.
SumOfLogs() - Constructor for class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Create a SumOfLogs instance
SumOfLogs(SumOfLogs) - Constructor for class org.apache.commons.math.stat.descriptive.summary.SumOfLogs
Copy constructor, creates a new SumOfLogs identical to the original
sumOfPowerDeviations(DoubleArrayList, int, double) - Static method in class cern.jet.stat.Descriptive
Returns Sum( (data[i]-c)k ); optimized for common parameters like c == 0.0 and/or k == -2 ..
sumOfPowerDeviations(DoubleArrayList, int, double, int, int) - Static method in class cern.jet.stat.Descriptive
Returns Sum( (data[i]-c)k ) for all i = from ..
sumOfPowerDeviations(DoubleArrayList, int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns Sum( (data[i]-c)k ); optimized for common parameters like c == 0.0 and/or k == -2 ..
sumOfPowerDeviations(DoubleArrayList, int, double, int, int) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns Sum( (data[i]-c)k ) for all i = from ..
sumOfPowerDeviations(FloatArrayList, int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns Sum( (data[i]-c)k ); optimized for common parameters like c == 0.0 and/or k == -2 ..
sumOfPowerDeviations(FloatArrayList, int, float, int, int) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns Sum( (data[i]-c)k ) for all i = from ..
sumOfPowers(int) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the k-th order sum of powers, which is Sum( x[i]k ).
sumOfPowers(int) - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns the k-th order sum of powers, which is Sum( x[i]k ).
sumOfPowers(DoubleArrayList, int) - Static method in class cern.jet.stat.Descriptive
Returns the sum of powers of a data sequence, which is Sum ( data[i]k ).
sumOfPowers(DoubleArrayList, int) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sum of powers of a data sequence, which is Sum ( data[i]k ).
sumOfPowers(FloatArrayList, int) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sum of powers of a data sequence, which is Sum ( data[i]k ).
sumOfPowers(int) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the k-th order sum of powers, which is Sum( x[i]k ).
sumOfPowers(int) - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns the k-th order sum of powers, which is Sum( x[i]k ).
sumOfPowers(int) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the k-th order sum of powers, which is Sum( x[i]k ).
sumOfPowers(int) - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns the k-th order sum of powers, which is Sum( x[i]k ).
sumOfSquaredDeviations(int, double) - Static method in class cern.jet.stat.Descriptive
Returns the sum of squared mean deviation of of a data sequence.
sumOfSquaredDeviations(int, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sum of squared mean deviation of of a data sequence.
sumOfSquaredDeviations(int, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sum of squared mean deviation of of a data sequence.
sumOfSquares() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares() - Method in class cern.hep.aida.bin.StaticBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares(DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the sum of squares of a data sequence.
sumOfSquares(DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the sum of squares of a data sequence.
sumOfSquares(FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the sum of squares of a data sequence.
sumOfSquares() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares() - Method in class hep.aida.tdouble.bin.StaticDoubleBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
sumOfSquares() - Method in class hep.aida.tfloat.bin.StaticFloatBin1D
Returns the sum of squares, which is Sum( x[i] * x[i] ).
SumOfSquares - Class in org.apache.commons.math.stat.descriptive.summary
Returns the sum of the squares of the available values.
SumOfSquares() - Constructor for class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Create a SumOfSquares instance
SumOfSquares(SumOfSquares) - Constructor for class org.apache.commons.math.stat.descriptive.summary.SumOfSquares
Copy constructor, creates a new SumOfSquares identical to the original
sumOfWeights() - Method in class hep.aida.ref.dataset.DataStatistics
Get the sum of weights for this data set.
sumOfWeights() - Method in class hep.aida.ref.histogram.Cloud
Get the sum of weights of of all the entries
sumOfWeights() - Method in class hep.aida.ref.histogram.Cloud1D
Get the sum of weights of of all the entries
sumOfWeights() - Method in class hep.aida.ref.histogram.Cloud2D
Get the sum of weights of of all the entries
sumOfWeights() - Method in class hep.aida.ref.histogram.Cloud3D
Get the sum of weights of of all the entries
sumSq(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the squares of the entries in the input array, or Double.NaN if the array is empty.
sumSq(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the sum of the squares of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
sumSqrEntries() - Method in class jhplot.bsom.Matrix
Summation of squared entries.
sumSquares(double[]) - Static method in class jhplot.math.ArrayMathUtils
Sums the squares of all components; also called the energy of the array.
sumSquares(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Sums the squares of all components; also called the energy of the array.
sumSquares(int[]) - Static method in class jhplot.math.ArrayMathUtils
Sums the squares of all components; also called the energy of the array.
sumSquares(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Sums the squares of all components; also called the energy of the array.
sumWW(int) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
sumWW(int) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
sumXW(int) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
sumXW(int) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
sumXXW(int) - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
sumXXW(int) - Method in interface hep.aida.ref.histogram.binner.Binner1D
 
sundayAfterAscension() - Method in class flanagan.math.TimeAndDate
 
sundayAfterAscension(int) - Method in class flanagan.math.TimeAndDate
 
sundayAfterCorpusChristi() - Method in class flanagan.math.TimeAndDate
 
sundayAfterCorpusChristi(int) - Method in class flanagan.math.TimeAndDate
 
sundayAfterEpiphany() - Method in class flanagan.math.TimeAndDate
 
sundayAfterEpiphany(int) - Method in class flanagan.math.TimeAndDate
 
supportsMultipleCursors() - Method in class hep.aida.ref.tuple.AbstractTuple
 
supportsMultipleCursors() - Method in class hep.aida.ref.tuple.ChainedTuple
 
supportsMultipleCursors() - Method in interface hep.aida.ref.tuple.FTuple
 
supportsMultipleCursors() - Method in class hep.aida.ref.tuple.FTupleAdapter
 
supportsMultipleCursors() - Method in class hep.aida.ref.tuple.Tuple
 
supportsRandomAccess() - Method in class hep.aida.ref.tuple.AbstractTuple
 
supportsRandomAccess() - Method in class hep.aida.ref.tuple.ChainedTuple
 
supportsRandomAccess() - Method in interface hep.aida.ref.tuple.FTuple
 
supportsRandomAccess() - Method in class hep.aida.ref.tuple.FTupleAdapter
 
supportsRandomAccess() - Method in class hep.aida.ref.tuple.Tuple
 
suppressMessages() - Method in class flanagan.math.ArrayMaths
 
suppressMessages() - Static method in class flanagan.math.Conv
 
suppressMessagesAM() - Static method in class flanagan.math.Conv
 
suppressMessagesTotal() - Static method in class flanagan.math.ArrayMaths
 
suppressNoConvergenceMessage() - Method in class flanagan.math.Maximisation
 
suppressNoConvergenceMessage() - Method in class flanagan.math.Minimisation
 
supressErrorMessage() - Method in class flanagan.math.Matrix
 
supressErrorMessages() - Method in class flanagan.analysis.Regression
 
supressNoConvergenceMessage() - Method in class flanagan.math.Minimisation
 
supressPrint() - Method in class flanagan.analysis.Regression
 
supressStats() - Method in class flanagan.analysis.Regression
 
supressYYplot() - Method in class flanagan.analysis.Regression
 
SUSPECTP - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Environment variable used in formatp1 to determine which p-values should be marked as suspect when printing test results.
suspend(SimProcess) - Method in class umontreal.iro.lecuyer.simprocs.DSOLProcessSimulator
 
suspend(SimProcess) - Method in class umontreal.iro.lecuyer.simprocs.ProcessSimulator
Suspends process.
suspend() - Method in class umontreal.iro.lecuyer.simprocs.SimProcess
This method can only be invoked for the EXECUTING or a DELAYED process.
suspend(SimProcess) - Method in class umontreal.iro.lecuyer.simprocs.ThreadProcessSimulator
 
SUSPENDED - Static variable in class umontreal.iro.lecuyer.simprocs.SimProcess
The process is not executing and will have to be reactivated by another process or event later on.
svd(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Constructs and returns the SingularValue-decomposition of the given matrix.
svd(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Constructs and returns the SingularValue-decomposition of the given matrix.
svout(int, int, float[], int, String) - Method in class org.netlib.arpack.ARPACK
No documentation was available when generating this method.
swap(DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleMatrix1D
Swaps each element this[i] with other[i].
swap(DoubleMatrix1D) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Swaps each element this[i] with other[i].
swap(ObjectMatrix1D) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Swaps each element this[i] with other[i].
swap(ObjectMatrix1D) - Method in class cern.colt.matrix.ObjectMatrix1D
Swaps each element this[i] with other[i].
swap(DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Swaps each element this[i] with other[i].
swap(DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
swap(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Swaps each element this[i] with other[i].
swap(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
swap(FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Swaps each element this[i] with other[i].
swap(FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
swap(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Swaps each element this[i] with other[i].
swap(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
swap(IntMatrix1D) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
swap(IntMatrix1D) - Method in class cern.colt.matrix.tint.IntMatrix1D
Swaps each element this[i] with other[i].
swap(LongMatrix1D) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
swap(LongMatrix1D) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Swaps each element this[i] with other[i].
swap(ObjectMatrix1D) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Swaps each element this[i] with other[i].
swap(ObjectMatrix1D) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Swaps each element this[i] with other[i].
swap(int, int) - Method in interface cern.colt.Swapper
Swaps the generic data g[a] with g[b].
swapArgs(DoubleDoubleFunction) - Static method in class cern.jet.math.Functions
Constructs a function that returns function.apply(b,a), i.e.
swapArgs(IntIntFunction) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns function.apply(b,a), i.e.
swapArgs(DComplexDComplexDComplexFunction) - Static method in class cern.jet.math.tdcomplex.DComplexFunctions
 
swapArgs(DoubleDoubleFunction) - Static method in class cern.jet.math.tdouble.DoubleFunctions
Constructs a function that returns function.apply(b,a), i.e.
swapArgs(FComplexFComplexFComplexFunction) - Static method in class cern.jet.math.tfcomplex.FComplexFunctions
 
swapArgs(FloatFloatFunction) - Static method in class cern.jet.math.tfloat.FloatFunctions
Constructs a function that returns function.apply(b,a), i.e.
swapArgs(IntIntFunction) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns function.apply(b,a), i.e.
swapArgs(LongLongFunction) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns function.apply(b,a), i.e.
swappedElements - Static variable in class cern.colt.Partitioning
 
Swapper - Interface in cern.colt
Interface for an object that knows how to swap elements at two positions (a,b).
symlink(String, String) - Method in class hep.aida.ref.tree.Tree
Create a symbolic link to an object in the ITree.
SymmetricMatrix - Class in hephysics.matrix
A simple implementation of a symmetric matrix.
SymmetricMatrix(int) - Constructor for class hephysics.matrix.SymmetricMatrix
Creates a new instance of SymmetricMatrix with all elements set to zero.
SymmetricMatrix(Matrix) - Constructor for class hephysics.matrix.SymmetricMatrix
Construct a SymmetricMatrix by copying an existing matrix.
SymmetricMatrix(int, double[], boolean) - Constructor for class hephysics.matrix.SymmetricMatrix
Creates a new instance of SymmetricMatrix with the given initial values.
SynchronizedDescriptiveStatistics - Class in org.apache.commons.math.stat.descriptive
Implementation of DescriptiveStatistics that is safe to use in a multithreaded environment.
SynchronizedDescriptiveStatistics() - Constructor for class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Construct an instance with infinite window
SynchronizedDescriptiveStatistics(int) - Constructor for class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Construct an instance with finite window
SynchronizedDescriptiveStatistics(SynchronizedDescriptiveStatistics) - Constructor for class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
A copy constructor.
SynchronizedMultivariateSummaryStatistics - Class in org.apache.commons.math.stat.descriptive
Implementation of MultivariateSummaryStatistics that is safe to use in a multithreaded environment.
SynchronizedMultivariateSummaryStatistics(int, boolean) - Constructor for class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Construct a SynchronizedMultivariateSummaryStatistics instance
SynchronizedSummaryStatistics - Class in org.apache.commons.math.stat.descriptive
Implementation of SummaryStatistics that is safe to use in a multithreaded environment.
SynchronizedSummaryStatistics() - Constructor for class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Construct a SynchronizedSummaryStatistics instance
SynchronizedSummaryStatistics(SynchronizedSummaryStatistics) - Constructor for class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
A copy constructor.
SystemTimeChrono - Class in umontreal.iro.lecuyer.util
Extends the AbstractChrono class to compute the total system time using Java's builtin System.nanoTime.
SystemTimeChrono() - Constructor for class umontreal.iro.lecuyer.util.SystemTimeChrono
Constructs a new chrono object and initializes it to zero.

T

t() - Method in class hephysics.vec.HepLorentzVector
Get time
t(double, double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
t(double, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
t(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
t(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
t(double, double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a t statistic given observed values and a comparison constant.
t(double, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a t statistic to use in comparing the mean of the dataset described by sampleStats to mu.
t(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a 2-sample t statistic, without the hypothesis of equal subpopulation variances.
t(StatisticalSummary, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Computes a 2-sample t statistic , comparing the means of the datasets described by two StatisticalSummary instances, without the assumption of equal subpopulation variances.
t(double, double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a t statistic given observed values and a comparison constant.
t(double, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a t statistic to use in comparing the mean of the dataset described by sampleStats to mu.
t(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a 2-sample t statistic, without the hypothesis of equal subpopulation variances.
t(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Computes a 2-sample t statistic , comparing the means of the datasets described by two StatisticalSummary instances, without the assumption of equal subpopulation variances.
T_ABS - Static variable in class flanagan.math.Fmath
 
TableFormat - Class in umontreal.iro.lecuyer.util
This class provides methods to format arrays and matrices into Strings in different styles.
take(int) - Method in class umontreal.iro.lecuyer.simprocs.Bin
The executing process invoking this method requests n tokens from this bin.
Tally - Class in umontreal.iro.lecuyer.stat
This type of statistical collector takes a sequence of real-valued observations and can return the average, the variance, a confidence interval for the theoretical mean, etc.
Tally() - Constructor for class umontreal.iro.lecuyer.stat.Tally
Constructs a new unnamed Tally statistical probe.
Tally(String) - Constructor for class umontreal.iro.lecuyer.stat.Tally
Constructs a new Tally statistical probe with name name.
TallyStore - Class in umontreal.iro.lecuyer.stat
This class is a variant of Tally for which the individual observations are stored in a list implemented as a DoubleArrayList.
TallyStore() - Constructor for class umontreal.iro.lecuyer.stat.TallyStore
Constructs a new TallyStore statistical probe.
TallyStore(String) - Constructor for class umontreal.iro.lecuyer.stat.TallyStore
Constructs a new TallyStore statistical probe with name name.
TallyStore(int) - Constructor for class umontreal.iro.lecuyer.stat.TallyStore
Constructs a new TallyStore statistical probe with given initial capacity capacity for its associated array.
TallyStore(String, int) - Constructor for class umontreal.iro.lecuyer.stat.TallyStore
Constructs a new TallyStore statistical probe with name name and given initial capacity capacity for its associated array.
TallyStore(DoubleArrayList) - Constructor for class umontreal.iro.lecuyer.stat.TallyStore
Constructs a new TallyStore statistical probe with given associated array.
tan - Static variable in class cern.jet.math.Functions
Function that returns Math.tan(a).
tan(double[]) - Static method in class cern.jet.math.tdcomplex.DComplex
 
tan - Static variable in class cern.jet.math.tdcomplex.DComplexFunctions
 
tan - Static variable in class cern.jet.math.tdouble.DoubleFunctions
Function that returns Math.tan(a).
tan(float[]) - Static method in class cern.jet.math.tfcomplex.FComplex
 
tan - Static variable in class cern.jet.math.tfcomplex.FComplexFunctions
 
tan - Static variable in class cern.jet.math.tfloat.FloatFunctions
Function that returns Math.tan(a).
tan(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
tan(double, double, double, double, double, double) - Static method in class flanagan.math.Fmath
 
tan(double, double, double) - Static method in class flanagan.math.Fmath
 
tan(double) - Static method in class flanagan.math.Fmath
 
tan() - Method in class jhplot.math.Complex
Tangent of this Complex number (doesn't change this Complex number).
tan(ValueErr) - Static method in class jhplot.math.ValueErr
Tangent of a value with error
TAN - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.tan method wrapped as a ComposableFunction.
tan() - Method in class org.apache.commons.math.complex.Complex
Compute the tangent of this complex number.
tan(Dfp) - Static method in class org.apache.commons.math.dfp.DfpMath
computes the tangent of the argument.
tan(double) - Static method in class org.apache.commons.math.util.FastMath
Tangent function
tanh(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
tanh(double) - Static method in class flanagan.math.Fmath
 
tanh(double) - Static method in class jhplot.math.num.special.Trigonometric
Returns the hyperbolic tangent of x.
tanh(ValueErr) - Static method in class jhplot.math.ValueErr
Hyperbolic tangent of value with error
TANH - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.tanh method wrapped as a ComposableFunction.
tanh() - Method in class org.apache.commons.math.complex.Complex
Compute the hyperbolic tangent of this complex number.
tanh(double) - Static method in class org.apache.commons.math.util.FastMath
Compute the hyperbolic tangent of a number.
TDistribution - Class in jhplot.math.num.pdf
Student's t distribution (1).
TDistribution() - Constructor for class jhplot.math.num.pdf.TDistribution
Default constructor.
TDistribution(double) - Constructor for class jhplot.math.num.pdf.TDistribution
Create a distribution with the given degrees of freedom.
TDistribution - Interface in org.apache.commons.math.distribution
Student's t-Distribution.
TDistributionImpl - Class in org.apache.commons.math.distribution
Default implementation of TDistribution.
TDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.TDistributionImpl
Create a t distribution using the given degrees of freedom and the specified inverse cumulative probability absolute accuracy.
TDistributionImpl(double) - Constructor for class org.apache.commons.math.distribution.TDistributionImpl
Create a t distribution using the given degrees of freedom.
TEN_NEG_POW - Static variable in class umontreal.iro.lecuyer.util.Num
Contains the precomputed negative powers of 10.
teraelectronvolt - Static variable in class cern.clhep.Units
 
tesla - Static variable in class cern.clhep.Units
 
test(int) - Static method in class cern.colt.Timer
Shows how to use a timer in convenient ways.
Test - Class in cern.hep.aida.ref
A very(!) basic test of the reference implementations of AIDA histograms.
Test() - Constructor for class cern.hep.aida.ref.Test
 
test(int, AbstractDistribution) - Static method in class cern.jet.random.Benchmark
Prints the first size random numbers generated by the distribution.
test(int, RandomEngine) - Static method in class cern.jet.random.engine.Benchmark
Prints the first size random numbers generated by the given engine.
test(long, long, long, int, int) - Static method in class cern.jet.random.sampling.RandomSampler
Tests the methods of this class.
test(long, long) - Static method in class cern.jet.random.sampling.RandomSamplingAssistant
Tests the methods of this class.
test(int, int) - Static method in class cern.jet.random.sampling.WeightedRandomSampler
Not yet commented.
test(long, long, long, int, int) - Static method in class cern.jet.random.tdouble.sampling.DoubleRandomSampler
Tests the methods of this class.
test(long, long) - Static method in class cern.jet.random.tdouble.sampling.DoubleRandomSamplingAssistant
Tests the methods of this class.
test(int, int) - Static method in class cern.jet.random.tdouble.sampling.WeightedDoubleRandomSampler
Not yet commented.
test(long, long, long, int, int) - Static method in class cern.jet.random.tfloat.sampling.FloatRandomSampler
Tests the methods of this class.
test(long, long) - Static method in class cern.jet.random.tfloat.sampling.FloatRandomSamplingAssistant
Tests the methods of this class.
test(int, int) - Static method in class cern.jet.random.tfloat.sampling.WeightedFloatRandomSampler
Not yet commented.
test(float) - Static method in class cern.jet.stat.quantile.EquiDepthHistogram
Not yet commented.
test(double) - Static method in class cern.jet.stat.tdouble.quantile.DoubleEquiDepthHistogram
Not yet commented.
test(float) - Static method in class cern.jet.stat.tfloat.quantile.FloatEquiDepthHistogram
Not yet commented.
test1() - Static method in class hep.aida.ref.function.FunctionCatalog
 
test2(int) - Static method in class cern.colt.map.Benchmark
 
Test2 - Class in cern.hep.aida.ref
A very(!) basic test of the reference implementations of AIDA histograms
Test2() - Constructor for class cern.hep.aida.ref.Test2
 
test2(int, AbstractDistribution) - Static method in class cern.jet.random.Benchmark
Prints the first size random numbers generated by the distribution.
test2(int, AbstractDistribution, AbstractDistribution) - Static method in class cern.jet.random.Benchmark
Prints the first size random numbers generated by the distribution.
test2() - Static method in class hep.aida.ref.function.FunctionCatalog
 
testArraySampling(int, int) - Static method in class cern.jet.random.sampling.RandomSamplingAssistant
Tests the methods of this class.
testArraySampling(int, int) - Static method in class cern.jet.random.tdouble.sampling.DoubleRandomSamplingAssistant
Tests the methods of this class.
testArraySampling(int, int) - Static method in class cern.jet.random.tfloat.sampling.FloatRandomSamplingAssistant
Tests the methods of this class.
TestCalculator - Class in jhpro.test
An example of how to calculate limits
TestCalculator() - Constructor for class jhpro.test.TestCalculator
 
TestCanvas - Class in jhplot.v3d
 
TestCanvas() - Constructor for class jhplot.v3d.TestCanvas
 
TestLimit - Class in jhpro.test
An example of how to calculate limits
TestLimit() - Constructor for class jhpro.test.TestLimit
 
TESTNAMES - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Name of each testType test.
testOfAdditionalTerms(double, int, double, int, int) - Static method in class flanagan.analysis.Regression
 
testOfAdditionalTerms_ArrayList(double, int, double, int, int) - Static method in class flanagan.analysis.Regression
 
testOfAdditionalTerms_Vector(double, int, double, int, int) - Static method in class flanagan.analysis.Regression
 
testOfAdditionalTermsFprobability(double, int, double, int, int) - Method in class flanagan.analysis.Regression
 
testOfAdditionalTermsFprobabilty(double, int, double, int, int) - Method in class flanagan.analysis.Regression
 
testOfAdditionalTermsFratio(double, int, double, int, int) - Method in class flanagan.analysis.Regression
 
tests(DoubleArrayList, double[]) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
Computes all EDF test statistics to compare the empirical distribution of U(0),..., U(N-1) with the uniform distribution, assuming that these sorted observations are in sortedData.
tests(DoubleArrayList, ContinuousDistribution, double[]) - Static method in class umontreal.iro.lecuyer.gof.GofFormat
The observations V are in data, not necessarily sorted, and their empirical distribution is compared with the continuous distribution dist.
TestUtils - Class in org.apache.commons.math.stat.inference
A collection of static methods to create inference test instances or to perform inference tests.
tetragamma(double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of the tetragamma function d2ψ(x)/d2x, the second derivative of the digamma function, evaluated at x.
TeV - Static variable in class cern.clhep.Units
 
Text(String, float, float) - Static method in class jhplot.jadraw.Diagram
Get a text object
TEXT - Static variable in class jhplot.shapes.HShape
 
Text - Class in jhplot.shapes
Draw a TEXT in the USER coordinate system.
Text(String, double, double, Font, Color) - Constructor for class jhplot.shapes.Text
Create a TEXT object
Text(String, double, double) - Constructor for class jhplot.shapes.Text
Create a TEXT object
TextBox(String, float, float) - Static method in class jhplot.jadraw.Diagram
A boxed text object
TextBox(String[], float, float) - Static method in class jhplot.jadraw.Diagram
A multiline boxed text object
TextDataReader - Class in umontreal.iro.lecuyer.util
Provides static methods to read data from text files.
TextDataReader() - Constructor for class umontreal.iro.lecuyer.util.TextDataReader
 
textVariance(char[]) - Static method in class jhplot.v3d.Util
 
thanksgivingDay() - Method in class flanagan.math.TimeAndDate
 
thanksgivingDay(int) - Method in class flanagan.math.TimeAndDate
 
theta() - Method in class hephysics.vec.Hep3Vector
angle theta (=atan2(perp(),z)
theta() - Method in class hephysics.vec.HepLorentzVector
Get theta angle
theta() - Method in class hephysics.vec.SpacePoint
Spherical theta
ThirdMoment - Class in org.apache.commons.math.stat.descriptive.moment
Computes a statistic related to the Third Central Moment.
ThirdMoment() - Constructor for class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
Create a FourthMoment instance
ThirdMoment(ThirdMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.ThirdMoment
Copy constructor, creates a new ThirdMoment identical to the original
ThreadCPUTimeChrono - Class in umontreal.iro.lecuyer.util
Extends the AbstractChrono class to compute the CPU time for a single thread.
ThreadCPUTimeChrono() - Constructor for class umontreal.iro.lecuyer.util.ThreadCPUTimeChrono
Constructs a ThreadCPUTimeChrono object associated with current thread and initializes it to zero.
ThreadCPUTimeChrono(Thread) - Constructor for class umontreal.iro.lecuyer.util.ThreadCPUTimeChrono
Constructs a ThreadCPUTimeChrono object associated with the given Thread variable and initializes it to zero.
ThreadProcessSimulator - Class in umontreal.iro.lecuyer.simprocs
Represents a process simulator using Java threads for process synchronization.
ThreadProcessSimulator() - Constructor for class umontreal.iro.lecuyer.simprocs.ThreadProcessSimulator
Creates a new ThreadProcessSimulator variable.
THREE_FIFTHS - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "3/5".
THREE_FIFTHS - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "3/5".
THREE_QUARTERS - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "3/4".
THREE_QUARTERS - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "3/4".
ThreeEighthesIntegrator - Class in org.apache.commons.math.ode.nonstiff
This class implements the 3/8 fourth order Runge-Kutta integrator for Ordinary Differential Equations.
ThreeEighthesIntegrator(double) - Constructor for class org.apache.commons.math.ode.nonstiff.ThreeEighthesIntegrator
Simple constructor.
throwError(String) - Static method in class jhplot.math.DoubleArray
Throws an error exception if an argument is invalid.
TiesStrategy - Enum in org.apache.commons.math.stat.ranking
Strategies for handling tied values in rank transformations.
time() - Method in class umontreal.iro.lecuyer.simevents.Event
Returns the (planned) time of occurence of this event.
time() - Static method in class umontreal.iro.lecuyer.simevents.Sim
Returns the current value of the simulation clock.
time() - Method in class umontreal.iro.lecuyer.simevents.Simulator
Returns the current value of the simulation clock.
TimeAndDate - Class in flanagan.math
 
TimeAndDate() - Constructor for class flanagan.math.TimeAndDate
 
Timer - Class in cern.colt
A handy stopwatch for benchmarking.
Timer() - Constructor for class cern.colt.Timer
Constructs a new timer, initially not started.
timer - Static variable in class jhplot.JHPlot
 
times(int) - Method in class cern.colt.list.AbstractBooleanList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractByteList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractCharList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractDoubleList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractFloatList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractIntList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractLongList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.AbstractShortList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.ObjectArrayList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.tbyte.AbstractByteList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.tchar.AbstractCharList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.tint.AbstractIntList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.tlong.AbstractLongList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.tobject.ObjectArrayList
Returns a list which is a concatenation of times times the receiver.
times(int) - Method in class cern.colt.list.tshort.AbstractShortList
Returns a list which is a concatenation of times times the receiver.
times(ErrorProp, double) - Method in class flanagan.analysis.ErrorProp
 
times(ErrorProp) - Method in class flanagan.analysis.ErrorProp
 
times(double) - Method in class flanagan.analysis.ErrorProp
 
times(ErrorProp, ErrorProp, double) - Static method in class flanagan.analysis.ErrorProp
 
times(ErrorProp, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
times(double, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
times(double, double) - Static method in class flanagan.analysis.ErrorProp
 
times(double) - Method in class flanagan.analysis.Stat
 
times(float) - Method in class flanagan.analysis.Stat
 
times(long) - Method in class flanagan.analysis.Stat
 
times(int) - Method in class flanagan.analysis.Stat
 
times(short) - Method in class flanagan.analysis.Stat
 
times(byte) - Method in class flanagan.analysis.Stat
 
times(BigDecimal) - Method in class flanagan.analysis.Stat
 
times(BigInteger) - Method in class flanagan.analysis.Stat
 
times(Complex) - Method in class flanagan.analysis.Stat
 
times(Phasor) - Method in class flanagan.analysis.Stat
 
times(Double) - Method in class flanagan.analysis.Stat
 
times(Float) - Method in class flanagan.analysis.Stat
 
times(Long) - Method in class flanagan.analysis.Stat
 
times(Integer) - Method in class flanagan.analysis.Stat
 
times(Short) - Method in class flanagan.analysis.Stat
 
times(Byte) - Method in class flanagan.analysis.Stat
 
times(double) - Method in class flanagan.math.ArrayMaths
 
times(Double) - Method in class flanagan.math.ArrayMaths
 
times(float) - Method in class flanagan.math.ArrayMaths
 
times(Float) - Method in class flanagan.math.ArrayMaths
 
times(long) - Method in class flanagan.math.ArrayMaths
 
times(Long) - Method in class flanagan.math.ArrayMaths
 
times(int) - Method in class flanagan.math.ArrayMaths
 
times(Integer) - Method in class flanagan.math.ArrayMaths
 
times(short) - Method in class flanagan.math.ArrayMaths
 
times(Short) - Method in class flanagan.math.ArrayMaths
 
times(BigDecimal) - Method in class flanagan.math.ArrayMaths
 
times(byte) - Method in class flanagan.math.ArrayMaths
 
times(Byte) - Method in class flanagan.math.ArrayMaths
 
times(BigInteger) - Method in class flanagan.math.ArrayMaths
 
times(Complex) - Method in class flanagan.math.ArrayMaths
 
times(Phasor) - Method in class flanagan.math.ArrayMaths
 
times(Matrix) - Method in class flanagan.math.Matrix
 
times(double[][]) - Method in class flanagan.math.Matrix
 
times(double) - Method in class flanagan.math.Matrix
 
times(Matrix, Matrix) - Static method in class flanagan.math.Matrix
 
times(Matrix, double[][]) - Static method in class flanagan.math.Matrix
 
times(Matrix, double) - Static method in class flanagan.math.Matrix
 
times(Complex) - Method in class jhplot.math.Complex
Complex multiplication (doesn't change this Complex number).
times(double) - Method in class jhplot.math.Complex
Returns this complex multiplied by the specified factor.
times(double[]...) - Static method in class jhplot.math.LinearAlgebra
Element-wise product of any number of arrays.
times(double[], double) - Static method in class jhplot.math.LinearAlgebra
Multiply each element of an array by a scalar.
times(double[][], double) - Static method in class jhplot.math.LinearAlgebra
Multiply each element in a matrix by a scalar
times(double[][], double[][]) - Static method in class jhplot.math.LinearAlgebra
Matrix multiplication according to the rules of linear algebra.
times(double[][], double[]) - Static method in class jhplot.math.LinearAlgebra
Product of a matrix and a vector (array) according to the rules of linear algebra.
times(ValueErr, double) - Method in class jhplot.math.ValueErr
Multiply two ValueErr numbers with correlation
times(ValueErr) - Method in class jhplot.math.ValueErr
Multiply this ValueErr number by a ValueErr number without correlation
times(double) - Method in class jhplot.math.ValueErr
Multiply this ValueErr number by a double.
times(ValueErr, ValueErr, double) - Static method in class jhplot.math.ValueErr
Multiply two ValueErr numbers with correlation
times(ValueErr, ValueErr) - Static method in class jhplot.math.ValueErr
Multiply two ValueErr numbers without correlation
times(double, ValueErr) - Static method in class jhplot.math.ValueErr
Multiply a double by a ValueErr number
times(double, double) - Static method in class jhplot.math.ValueErr
Multiply a double number by a double and return product as ValueErr
timesEquals(ErrorProp, double) - Method in class flanagan.analysis.ErrorProp
 
timesEquals(ErrorProp) - Method in class flanagan.analysis.ErrorProp
 
timesEquals(double) - Method in class flanagan.analysis.ErrorProp
 
timesEquals(Matrix) - Method in class flanagan.math.Matrix
 
timesEquals(double) - Method in class flanagan.math.Matrix
 
timesEquals(ValueErr, double) - Method in class jhplot.math.ValueErr
Multiply this ValueErr number by an ValueErr number and replace this by the product with correlation
timesEquals(ValueErr) - Method in class jhplot.math.ValueErr
Multiply this ValueErr number by an ValueErr number and replace this by the product with no correlation
timesEquals(double) - Method in class jhplot.math.ValueErr
Multiply this ValueErr number by a double and replace it by the product
TimeUnit - Enum in umontreal.iro.lecuyer.util
 
title() - Method in class hep.aida.ref.fitter.InternalFitFunction
 
title() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
title() - Method in class hep.aida.ref.function.AbstractIFunction
 
title() - Method in class hep.aida.ref.function.BaseModelFunction
 
title() - Method in class hep.aida.ref.function.FunctionCore
 
title() - Method in class hep.aida.ref.function.SumOfFunctions
 
title() - Method in class hep.aida.ref.histogram.AbstractBaseHistogram
Get the histogram title.
title() - Method in class hep.aida.ref.histogram.DataPointSet
 
title() - Method in class hep.aida.ref.tuple.AbstractTuple
 
title() - Method in interface hep.aida.ref.tuple.FTuple
 
title() - Method in class hep.aida.ref.tuple.FTupleAdapter
 
title() - Method in interface hep.aida.tdouble.DoubleIHistogram
Title of the histogram (will be set only in the constructor).
title() - Method in interface hep.aida.tfloat.FloatIHistogram
Title of the histogram (will be set only in the constructor).
Title - Static variable in class jhplot.HPlotJa
 
TITLE_CHANGED - Static variable in class hep.aida.ref.function.FunctionChangedEvent
 
titleKey - Static variable in class hep.aida.ref.Annotation
 
toArray(Object[]) - Method in class cern.colt.list.ObjectArrayList
Returns an array containing all of the elements in the receiver in the correct order.
toArray(Object[]) - Method in class cern.colt.list.tobject.ObjectArrayList
Returns an array containing all of the elements in the receiver in the correct order.
toArray() - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(double[]) - Method in class cern.colt.matrix.DoubleMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a 2-dimensional array containing the cell values.
toArray(double[]) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray(Object[]) - Method in class cern.colt.matrix.impl.DenseObjectMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(Object[]) - Method in class cern.colt.matrix.ObjectMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(double[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a 3-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
toArray(double[]) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
toArray() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
toArray() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
toArray() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(double[]) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
toArray(double[]) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
toArray() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
toArray() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
toArray() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(float[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a 3-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
toArray(float[]) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
toArray() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
toArray() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
toArray() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(float[]) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
toArray(float[]) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
toArray() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
toArray() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
toArray() - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
toArray(int[]) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
toArray() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
toArray() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
toArray() - Method in class cern.colt.matrix.tint.IntMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(int[]) - Method in class cern.colt.matrix.tint.IntMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
toArray(long[]) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
toArray() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
toArray() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
toArray() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(long[]) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
toArray(Object[]) - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Constructs and returns a 1-dimensional array containing the cell values.
toArray(Object[]) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Fills the cell values into the specified 1-dimensional array.
toArray() - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a 2-dimensional array containing the cell values.
toArray() - Method in class jhplot.math.num.DoubleArray
Convert this array into a native array.
toArray() - Method in class org.apache.commons.math.linear.AbstractRealVector
Convert the vector to a double array.
toArray() - Method in class org.apache.commons.math.linear.ArrayFieldVector
Convert the vector to a T array.
toArray() - Method in class org.apache.commons.math.linear.ArrayRealVector
Convert the vector to a double array.
toArray() - Method in interface org.apache.commons.math.linear.FieldVector
Convert the vector to a T array.
toArray() - Method in class org.apache.commons.math.linear.OpenMapRealVector
Convert the vector to a double array.
toArray() - Method in interface org.apache.commons.math.linear.RealVector
Convert the vector to a double array.
toArray() - Method in class org.apache.commons.math.linear.SparseFieldVector
Convert the vector to a T array.
toArray() - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
toArray(T[]) - Method in class umontreal.iro.lecuyer.stat.list.ListOfStatProbes
 
toASCIIFile(File) - Method in interface jhplot.math.io.FilePrintable
 
toBitVector() - Method in class cern.colt.bitvector.BitMatrix
Converts the receiver to a bitvector.
toBitVector() - Method in class cern.colt.list.MinMaxNumberList
Returns the receiver seen as bitvector.
toBitVector() - Method in class cern.colt.list.tlong.MinMaxNumberList
Returns the receiver seen as bitvector.
toBitVector() - Method in class cern.colt.matrix.tbit.BitMatrix
Converts the receiver to a bitvector.
toBlocksLayout(T[][]) - Static method in class org.apache.commons.math.linear.BlockFieldMatrix
Convert a data array from raw layout to blocks layout.
toBlocksLayout(double[][]) - Static method in class org.apache.commons.math.linear.BlockRealMatrix
Convert a data array from raw layout to blocks layout.
toClipBoard() - Method in interface jhplot.math.io.ClipBoardPrintable
 
toCommandLine(String) - Method in class jhplot.math.Slicing
 
toCronbach() - Method in class flanagan.analysis.Scores
 
toCSV(double[]...) - Static method in class umontreal.iro.lecuyer.charts.PlotFormat
Stores data tables data into a String with format CSV (comma-separated value tabular data).
toCSV(XYSeriesCollection) - Static method in class umontreal.iro.lecuyer.charts.PlotFormat
Stores series collection data into a String with format CSV (comma-separated value tabular data).
toCustomizedFormat(String, String, String, String, int, double[]...) - Static method in class umontreal.iro.lecuyer.charts.PlotFormat
Stores data tables data into a String with customized format.
toCustomizedFormat(String, String, String, String, int, XYSeriesCollection) - Static method in class umontreal.iro.lecuyer.charts.PlotFormat
Stores data tables data into a String with customized format from an XYSeriesCollection variable.
toDegrees(double) - Static method in class org.apache.commons.math.util.FastMath
Convert radians to degrees, with error of less than 0.5 ULP
toDouble(float[]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble(long[]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble(int[]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble(float[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble(long[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble(int[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toDouble() - Method in class org.apache.commons.math.dfp.Dfp
Convert the instance into a double.
toFile(String) - Method in class jhplot.H1D
Write the H1D histogram to a file
toFile(String) - Method in class jhplot.HProf1D
Write the profile histogram to a file
toFile(String) - Method in class jhplot.P0D
Write a P0D to an external file.
toFile(String) - Method in class jhplot.P0I
Write a P0I to an external file.
toFile(String) - Method in class jhplot.P1D
Write a P1D to an external file.
toFile(String) - Method in class jhplot.P2D
Write a P2D to an external file.
toFile(String) - Method in class jhplot.P3D
Write a P3D to an external file.
toFile(String) - Method in class jhplot.PND
Write a PND to an external file.
toFile(String) - Method in class jhplot.PNI
Write a PNI to an external file.
toFileAsLatex(String, DecimalFormat, DecimalFormat) - Method in class jhplot.P1D
Write a File in form of LaTeX table from values in the container P1D
toFloat(double[]) - Static method in class jhplot.math.ArrayMathUtils
 
toFloat(long[]) - Static method in class jhplot.math.ArrayMathUtils
 
toFloat(int[]) - Static method in class jhplot.math.ArrayMathUtils
 
toFloat(double[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toFloat(long[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toFloat(int[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toGNUPlot(double[]...) - Static method in class umontreal.iro.lecuyer.charts.PlotFormat
Stores data tables data into a String, with format understandable by GNUPlot.
toGNUPlot(XYSeriesCollection) - Static method in class umontreal.iro.lecuyer.charts.PlotFormat
Stores series collection data into a String, with format understandable by GNUPlot.
toInt(double[]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(float[]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(long[]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(float[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(double[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toInt(long[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toLatex(double) - Method in class umontreal.iro.lecuyer.charts.Axis
Formats and returns a string containing a LATEX-compatible source code which represents this axis and its parameters.
toLatex(double, double) - Method in class umontreal.iro.lecuyer.charts.BoxChart
NOT IMPLEMENTED.
toLatex(double, double, double, double) - Method in class umontreal.iro.lecuyer.charts.BoxSeriesCollection
NOT IMPLEMENTED: To do.
toLatex(double, double) - Method in class umontreal.iro.lecuyer.charts.CategoryChart
Transforms the chart into LATEX form and returns it as a String.
toLatex(double, double) - Method in class umontreal.iro.lecuyer.charts.EmpiricalChart
 
toLatex(double, double, double, double, double, double, double, double) - Method in class umontreal.iro.lecuyer.charts.EmpiricalSeriesCollection
 
toLatex(double, double) - Method in class umontreal.iro.lecuyer.charts.HistogramChart
 
toLatex(double, double, double, double, double, double, double, double) - Method in class umontreal.iro.lecuyer.charts.HistogramSeriesCollection
 
toLatex(double, double) - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Same as in XYChart.
toLatex(double, double) - Method in class umontreal.iro.lecuyer.charts.ScatterChart
 
toLatex(double, double, double, double) - Method in class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
Formats and returns a string containing a LATEX-compatible source code which represents this data series collection.
toLatex(double, double, double, double, double, double, double, double) - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Formats and returns a string containing a LATEX-compatible source code which represents this data series collection.
toLatex(double, double) - Method in class umontreal.iro.lecuyer.charts.XYChart
Exports the chart to a LATEX source code using PGF/TikZ.
toLatex(double, double) - Method in class umontreal.iro.lecuyer.charts.XYLineChart
 
toLatex(double, double, double, double, double, double, double, double) - Method in class umontreal.iro.lecuyer.charts.XYListSeriesCollection
 
toLatexCdf(int, int) - Method in class umontreal.iro.lecuyer.charts.ContinuousDistChart
Exports a chart of the cdf to a LATEX source code using PGF/TikZ.
toLatexCdf(int, int) - Method in class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Exports a chart of the cumulative probability to a LATEX source code using PGF/TikZ.
toLatexDensity(int, int) - Method in class umontreal.iro.lecuyer.charts.ContinuousDistChart
Similar to toLatexCdf, but for the probability density instead of the cdf.
toLatexFile(String, double, double) - Method in class umontreal.iro.lecuyer.charts.XYChart
Transforms the chart to LATEX form and writes it in file fileName.
toLatexProb(int, int) - Method in class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Similar to toLatexCdf, but for the probability instead of the cdf.
tolerance() - Method in class cern.colt.matrix.linalg.Property
Returns the current tolerance.
tolerance() - Method in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
Returns the current tolerance.
tolerance() - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Returns the current tolerance.
tolerance() - Method in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
Returns the current tolerance.
tolerance() - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Returns the current tolerance.
toList() - Method in class cern.colt.list.AbstractBooleanList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractByteList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractCharList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractCollection
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractDoubleList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractFloatList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractIntList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractLongList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.AbstractShortList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.ObjectArrayList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.tbyte.AbstractByteList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.tchar.AbstractCharList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.tint.AbstractIntList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.tlong.AbstractLongList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.tobject.ObjectArrayList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList() - Method in class cern.colt.list.tshort.AbstractShortList
Returns a java.util.ArrayList containing all the elements in the receiver.
toList(DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleFactory1D
Constructs a list from the given matrix.
toList(ObjectMatrix1D) - Method in class cern.colt.matrix.ObjectFactory1D
Constructs a list from the given matrix.
toList(DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexFactory1D
Constructs a list from the given matrix.
toList(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.DoubleFactory1D
Constructs a list from the given matrix.
toList(FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexFactory1D
Constructs a list from the given matrix.
toList(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.FloatFactory1D
Constructs a list from the given matrix.
toList(IntMatrix1D) - Method in class cern.colt.matrix.tint.IntFactory1D
Constructs a list from the given matrix.
toList(LongMatrix1D) - Method in class cern.colt.matrix.tlong.LongFactory1D
Constructs a list from the given matrix.
toList(ObjectMatrix1D) - Method in class cern.colt.matrix.tobject.ObjectFactory1D
Constructs a list from the given matrix.
toLong(double[]) - Static method in class jhplot.math.ArrayMathUtils
 
toLong(float[]) - Static method in class jhplot.math.ArrayMathUtils
 
toLong(int[]) - Static method in class jhplot.math.ArrayMathUtils
 
toLong(float[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toLong(double[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toLong(int[][]) - Static method in class jhplot.math.ArrayMathUtils
 
toNet() - Method in class umontreal.iro.lecuyer.hups.DigitalSequence
Transforms this digital sequence into a digital net without changing the coordinates of the points.
toNet() - Method in class umontreal.iro.lecuyer.hups.DigitalSequenceBase2
Transforms this digital sequence into a digital net without changing the coordinates of the points.
toNetShiftCj() - Method in class umontreal.iro.lecuyer.hups.DigitalSequence
Transforms this digital sequence into a digital net by adding one dimension and shifting all coordinates by one position.
toNetShiftCj() - Method in class umontreal.iro.lecuyer.hups.DigitalSequenceBase2
Transforms this digital sequence into a digital net by adding one dimension and shifting all coordinates by one position.
tonToKg(double) - Static method in class flanagan.math.Conv
 
tonToKg(double) - Static method in class flanagan.math.Fmath
 
toPCA() - Method in class flanagan.analysis.Scores
 
toRadians(double) - Static method in class org.apache.commons.math.util.FastMath
Convert degrees to radians, with error of less than 0.5 ULP
toShowableHistogram(ICloud1D, int, double, double) - Static method in class hep.aida.ref.histogram.HistUtils
Create an IHistogram1D and fill it from an ICloud1D.
toShowableHistogram(ICloud2D, int, double, double, int, double, double) - Static method in class hep.aida.ref.histogram.HistUtils
Create an IHistogram2D and fill it from an ICloud2D.
toShowableHistogram(ICloud3D, int, double, double, int, double, double, int, double, double) - Static method in class hep.aida.ref.histogram.HistUtils
Create an IHistogram3D and fill it from an ICloud3D.
toSourceCode(DoubleMatrix1D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(DoubleMatrix2D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(DoubleMatrix3D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(ObjectMatrix1D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(ObjectMatrix2D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(ObjectMatrix3D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(DoubleMatrix3D) - Method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(FloatMatrix3D) - Method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(IntMatrix1D) - Method in class cern.colt.matrix.tint.algo.IntFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(IntMatrix3D) - Method in class cern.colt.matrix.tint.algo.IntFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(LongMatrix1D) - Method in class cern.colt.matrix.tlong.algo.LongFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(LongMatrix3D) - Method in class cern.colt.matrix.tlong.algo.LongFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(ObjectMatrix1D) - Method in class cern.colt.matrix.tobject.algo.ObjectFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.algo.ObjectFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSourceCode(ObjectMatrix3D) - Method in class cern.colt.matrix.tobject.algo.ObjectFormatter
Returns a string s such that Object[] m = s is a legal Java statement.
toSplitDouble() - Method in class org.apache.commons.math.dfp.Dfp
Convert the instance into a split double.
toStat() - Method in class flanagan.math.ArrayMaths
 
toString(byte[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(char[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(double[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(float[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(int[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(long[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(Object[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(short[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString(boolean[]) - Static method in class cern.colt.Arrays
Returns a string representation of the specified array.
toString() - Method in class cern.colt.bitvector.BitMatrix
Returns a (very crude) string representation of the receiver.
toString() - Method in class cern.colt.bitvector.BitVector
Returns a string representation of the receiver.
toString() - Method in class cern.colt.list.AbstractBooleanList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractByteList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractCharList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractCollection
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractDoubleList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractFloatList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractIntList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractLongList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.AbstractShortList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.ObjectArrayList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.tboolean.AbstractBooleanList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.tbyte.AbstractByteList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.tchar.AbstractCharList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.tdouble.AbstractDoubleList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.tfloat.AbstractFloatList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.tint.AbstractIntList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.tlong.AbstractLongList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.tobject.ObjectArrayList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.list.tshort.AbstractShortList
Returns a string representation of the receiver, containing the String representation of each element.
toString() - Method in class cern.colt.map.AbstractDoubleIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.AbstractIntDoubleMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.AbstractIntIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.AbstractIntObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.AbstractLongObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tint.AbstractIntIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tlong.AbstractIntLongMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tlong.AbstractLongIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tlong.AbstractLongLongMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString() - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by key.
toString(DoubleMatrix1D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string representation of the given matrix.
toString(DoubleMatrix2D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string representation of the given matrix.
toString(DoubleMatrix3D) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string representation of the given matrix.
toString() - Method in class cern.colt.matrix.DoubleMatrix1D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.DoubleMatrix2D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.DoubleMatrix3D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.io.MatrixInfo
Returns a string representation of the specifier.
toString() - Method in class cern.colt.matrix.io.VectorInfo
Returns a string representation of the specifier.
toString(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.linalg.CholeskyDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.linalg.EigenvalueDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.linalg.LUDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.linalg.LUDecompositionQuick
Returns a String with (propertyName, propertyValue) pairs.
toString(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
Returns summary information about the given matrix A.
toString() - Method in class cern.colt.matrix.linalg.QRDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.linalg.SingularValueDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString(ObjectMatrix1D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string representation of the given matrix.
toString(ObjectMatrix2D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string representation of the given matrix.
toString(ObjectMatrix3D) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string representation of the given matrix.
toString() - Method in class cern.colt.matrix.ObjectMatrix1D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.ObjectMatrix2D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.ObjectMatrix3D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tbit.BitMatrix
Returns a (very crude) string representation of the receiver.
toString() - Method in class cern.colt.matrix.tbit.BitVector
Returns a string representation of the receiver.
toString() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns a string representation using default formatting ("%.4f").
toString(String) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns a string representation using given format
toString() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns a string representation using default formatting ("%.4f").
toString(String) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns a string representation using using given format
toString() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns a string representation using default formatting ("%.4f").
toString(String) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns a string representation using using given format
toString() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
toString() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
toString() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleCholeskyDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleEigenvalueDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleLUDecompositionQuick
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleQRDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.tdouble.algo.decomposition.DenseDoubleSingularValueDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns a String with (propertyName, propertyValue) pairs.
toString(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Returns a string representation of the given matrix.
toString(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Returns a string representation of the given matrix.
toString(DoubleMatrix3D) - Method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Returns a string representation of the given matrix.
toString(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
Returns summary information about the given matrix A.
toString() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
toString() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
 
toString() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
toString() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
toString() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
toString() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns a string representation using default formatting ("%.4f").
toString(String) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns a string representation using given format
toString() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns a string representation using default formatting ("%.4f").
toString(String) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns a string representation using using given format
toString() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns a string representation using default formatting ("%.4f").
toString(String) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns a string representation using using given format
toString() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
toString() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
toString() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatCholeskyDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatEigenvalueDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatLUDecompositionQuick
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatQRDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString() - Method in class cern.colt.matrix.tfloat.algo.decomposition.DenseFloatSingularValueDecomposition
Returns a String with (propertyName, propertyValue) pairs.
toString(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns a String with (propertyName, propertyValue) pairs.
toString(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Returns a string representation of the given matrix.
toString(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Returns a string representation of the given matrix.
toString(FloatMatrix3D) - Method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Returns a string representation of the given matrix.
toString(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
Returns summary information about the given matrix A.
toString() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
toString() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
 
toString() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
toString() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
toString() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
toString(IntMatrix1D) - Method in class cern.colt.matrix.tint.algo.IntFormatter
Returns a string representation of the given matrix.
toString(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntFormatter
Returns a string representation of the given matrix.
toString(IntMatrix3D) - Method in class cern.colt.matrix.tint.algo.IntFormatter
Returns a string representation of the given matrix.
toString(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
Returns summary information about the given matrix A.
toString() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
toString() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
 
toString() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
toString() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
toString() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
toString() - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tint.IntMatrix2D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tint.IntMatrix3D
Returns a string representation using default formatting.
toString(LongMatrix1D) - Method in class cern.colt.matrix.tlong.algo.LongFormatter
Returns a string representation of the given matrix.
toString(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongFormatter
Returns a string representation of the given matrix.
toString(LongMatrix3D) - Method in class cern.colt.matrix.tlong.algo.LongFormatter
Returns a string representation of the given matrix.
toString(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
Returns summary information about the given matrix A.
toString() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
toString() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
 
toString() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
toString() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
toString() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
toString() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Returns a string representation using default formatting.
toString(ObjectMatrix1D) - Method in class cern.colt.matrix.tobject.algo.ObjectFormatter
Returns a string representation of the given matrix.
toString(ObjectMatrix2D) - Method in class cern.colt.matrix.tobject.algo.ObjectFormatter
Returns a string representation of the given matrix.
toString(ObjectMatrix3D) - Method in class cern.colt.matrix.tobject.algo.ObjectFormatter
Returns a string representation of the given matrix.
toString() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
toString() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
toString() - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Returns a string representation using default formatting.
toString() - Method in class cern.colt.Timer
Returns a String representation of the receiver.
toString() - Method in class cern.hep.aida.bin.AbstractBin
Returns a String representation of the receiver.
toString() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns a String representation of the receiver.
toString() - Method in class cern.hep.aida.bin.DynamicBin1D
Returns a String representation of the receiver.
toString() - Method in class cern.hep.aida.bin.MightyStaticBin1D
Returns a String representation of the receiver.
toString() - Method in class cern.hep.aida.bin.QuantileBin1D
Returns a String representation of the receiver.
toString(IAxis) - Method in class cern.hep.aida.ref.Converter
Returns a string representation of the given argument.
toString(IHistogram1D) - Method in class cern.hep.aida.ref.Converter
Returns a string representation of the given argument.
toString(IHistogram2D) - Method in class cern.hep.aida.ref.Converter
Returns a string representation of the given argument.
toString(IHistogram3D) - Method in class cern.hep.aida.ref.Converter
Returns a string representation of the given argument.
toString() - Method in class cern.jet.random.Beta
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Binomial
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.BreitWigner
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.ChiSquare
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Empirical
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.EmpiricalWalker
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Exponential
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.ExponentialPower
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Gamma
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Hyperbolic
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.HyperGeometric
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Logarithmic
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.NegativeBinomial
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Normal
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Poisson
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.PoissonSlow
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.StudentT
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.Beta
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.Binomial
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.BreitWigner
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.ChiSquare
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.DoubleUniform
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.Empirical
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.EmpiricalWalker
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.Exponential
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.ExponentialPower
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.Gamma
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.Hyperbolic
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.HyperGeometric
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.Logarithmic
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.NegativeBinomial
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.Normal
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.Poisson
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.PoissonSlow
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.StudentT
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.VonMises
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tdouble.Zeta
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.tfloat.FloatUniform
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Uniform
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.VonMises
Returns a String representation of the receiver.
toString() - Method in class cern.jet.random.Zeta
Returns a String representation of the receiver.
toString() - Method in class cern.jet.stat.tdouble.quantile.DoubleBuffer
Returns a String representation of the receiver.
toString() - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Returns a String representation of the receiver.
toString() - Method in class flanagan.analysis.ErrorProp
 
toString(ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
toString() - Method in class hep.aida.ref.event.TreeEvent
 
toString() - Method in class hep.aida.ref.function.BaseModelFunction
 
toString() - Method in class hep.aida.ref.function.FunctionCatalog
 
toString(IFunction) - Static method in class hep.aida.ref.function.FunctionCreator
 
toString() - Method in class hep.aida.ref.histogram.binner.AbstractBinner1D
 
toString() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns a String representation of the receiver.
toString() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns a String representation of the receiver.
toString() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns a String representation of the receiver.
toString() - Method in class hep.aida.tdouble.bin.MightyStaticDoubleBin1D
Returns a String representation of the receiver.
toString() - Method in class hep.aida.tdouble.bin.QuantileDoubleBin1D
Returns a String representation of the receiver.
toString(DoubleIAxis) - Method in class hep.aida.tdouble.ref.DoubleConverter
Returns a string representation of the given argument.
toString(DoubleIHistogram1D) - Method in class hep.aida.tdouble.ref.DoubleConverter
Returns a string representation of the given argument.
toString(DoubleIHistogram2D) - Method in class hep.aida.tdouble.ref.DoubleConverter
Returns a string representation of the given argument.
toString(DoubleIHistogram3D) - Method in class hep.aida.tdouble.ref.DoubleConverter
Returns a string representation of the given argument.
toString() - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns a String representation of the receiver.
toString() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns a String representation of the receiver.
toString() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns a String representation of the receiver.
toString() - Method in class hep.aida.tfloat.bin.MightyStaticFloatBin1D
Returns a String representation of the receiver.
toString() - Method in class hep.aida.tfloat.bin.QuantileFloatBin1D
Returns a String representation of the receiver.
toString(FloatIAxis) - Method in class hep.aida.tfloat.ref.FloatConverter
Returns a string representation of the given argument.
toString(FloatIHistogram1D) - Method in class hep.aida.tfloat.ref.FloatConverter
Returns a string representation of the given argument.
toString(FloatIHistogram2D) - Method in class hep.aida.tfloat.ref.FloatConverter
Returns a string representation of the given argument.
toString(FloatIHistogram3D) - Method in class hep.aida.tfloat.ref.FloatConverter
Returns a string representation of the given argument.
toString() - Method in class hephysics.matrix.BasicMatrix
 
toString(Matrix) - Static method in class hephysics.matrix.MatrixOp
 
toString() - Method in class hephysics.matrix.SymmetricMatrix
 
toString() - Method in class hephysics.particle.HEParticle
Convert to string
toString() - Method in class hephysics.particle.LParticle
Convert to string
toString() - Method in class hephysics.vec.Hep3Matrix
 
toString() - Method in class hephysics.vec.Hep3Vector
 
toString() - Method in class hephysics.vec.HepLorentzVector
Convert to string
toString() - Method in class hephysics.vec.SpacePoint
Output Stream
toString(Hep3Vector) - Static method in class hephysics.vec.VecOp
 
toString(HepLorentzVector) - Static method in class hephysics.vec.VecOp
 
toString(Hep3Matrix) - Static method in class hephysics.vec.VecOp
 
toString() - Method in class jhplot.FND
Convert to string
toString() - Method in class jhplot.H1D
Convert the histogram to a string
toString() - Method in class jhplot.HLabelEq
 
toString() - Method in class jhplot.io.FileRoot
Return all root objects in form of a string.
toString(double[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a comma delimited string representing the value of the array.
toString(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns a comma delimited string representing the value of the array.
toString(int[]) - Static method in class jhplot.math.ArrayMathUtils
Returns a comma delimited string representing the value of the array.
toString(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Returns a comma delimited string representing the value of the array.
toString() - Method in class jhplot.math.Complex
String representation of this Complex number.
toString(double[]...) - Static method in class jhplot.math.DoubleArray
Generates a string that holds a nicely organized space-seperated version of a matrix or array.
toString(String, double[]...) - Static method in class jhplot.math.DoubleArray
Generates a string that holds a nicely organized version of a matrix or array.
toString(int[]...) - Static method in class jhplot.math.IntegerArray
 
toString() - Method in class jhplot.math.ValueErr
Convert to a string
toString() - Method in class jhplot.P0D
Get a P0D as a string.
toString() - Method in class jhplot.P0I
Get a P0I as a string.
toString() - Method in class jhplot.P1D
Convert to a string
toString() - Method in class jhplot.P2D
Convert to a string
toString() - Method in class jhplot.PND
Get a string representing PND
toString() - Method in class jhplot.PNI
Get a string representing PNI
toString() - Method in class jhplot.shapes.Arrow
Represent it as a string
toString() - Method in class jhplot.shapes.Circle
Show it as a string
toString() - Method in class jhplot.shapes.Ellipse
Show it as a string
toString() - Method in class jhplot.shapes.Line
Show it as a string
toString() - Method in class jhplot.shapes.Picture
 
toString() - Method in class jhplot.shapes.Rectan
 
toString() - Method in class jhplot.shapes.Text
Show this object
toString() - Method in class jhplot.v3d.Vector3d
 
toString() - Method in class jminhep.cluster.DataHolder
Convert to string all entries of the data holder
toString() - Method in class jminhep.cluster.DataPoint
Returns a string representation of this DataPoint
toString() - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Returns a string representation of the polynomial.
toString() - Method in class org.apache.commons.math.dfp.Dfp
Get a string representation of the instance.
toString() - Method in class org.apache.commons.math.exception.util.DummyLocalizable
toString() - Method in class org.apache.commons.math.fraction.BigFraction
Returns the String representing this fraction, ie "num / dem" or just "num" if the denominator is one.
toString() - Method in class org.apache.commons.math.fraction.Fraction
Returns the String representing this fraction, ie "num / dem" or just "num" if the denominator is one.
toString() - Method in class org.apache.commons.math.genetics.AbstractListChromosome
toString() - Method in class org.apache.commons.math.genetics.ChromosomePair
toString() - Method in class org.apache.commons.math.genetics.ListPopulation
toString() - Method in class org.apache.commons.math.genetics.RandomKey
toString() - Method in class org.apache.commons.math.geometry.RotationOrder
Get a string representation of the instance.
toString() - Method in class org.apache.commons.math.geometry.Vector3D
Get a string representation of this vector.
toString() - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Get a string representation for this matrix.
toString() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Get a string representation for this matrix.
toString() - Method in class org.apache.commons.math.linear.ArrayRealVector
toString() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Get a string representation for this matrix.
toString() - Method in enum org.apache.commons.math.optimization.linear.Relationship
toString() - Method in class org.apache.commons.math.stat.clustering.EuclideanIntegerPoint
toString() - Method in class org.apache.commons.math.stat.descriptive.DescriptiveStatistics
Generates a text report displaying univariate statistics from values that have been added.
toString() - Method in class org.apache.commons.math.stat.descriptive.MultivariateSummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math.stat.descriptive.StatisticalSummaryValues
Generates a text report displaying values of statistics.
toString() - Method in class org.apache.commons.math.stat.descriptive.SummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedDescriptiveStatistics
Generates a text report displaying univariate statistics from values that have been added.
toString() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedMultivariateSummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math.stat.descriptive.SynchronizedSummaryStatistics
Generates a text report displaying summary statistics from values that have been added.
toString() - Method in class org.apache.commons.math.stat.Frequency
Return a string representation of this frequency distribution.
toString() - Method in class org.apache.commons.math.util.MultidimensionalCounter
toString() - Method in class umontreal.iro.lecuyer.charts.BoxSeriesCollection
Returns in a String all data contained in the current object.
toString() - Method in class umontreal.iro.lecuyer.charts.SSJCategorySeriesCollection
Returns in a String all data contained in the current object.
toString() - Method in class umontreal.iro.lecuyer.charts.SSJXYSeriesCollection
Returns in a String all data contained in the current object.
toString() - Method in class umontreal.iro.lecuyer.functionfit.LeastSquares
Calls toString with the associated points.
toString(double[], double[]) - Static method in class umontreal.iro.lecuyer.functionfit.PolInterp
Makes a string representation of a set of points.
toString() - Method in class umontreal.iro.lecuyer.functionfit.PolInterp
 
toString() - Method in class umontreal.iro.lecuyer.functions.Polynomial
 
toString() - Method in class umontreal.iro.lecuyer.gof.GofStat.OutcomeCategoriesChi2
Provides a report on the categories.
toString() - Method in class umontreal.iro.lecuyer.hups.AntitheticPointSet
 
toString() - Method in class umontreal.iro.lecuyer.hups.BakerTransformedPointSet
 
toString() - Method in class umontreal.iro.lecuyer.hups.CachedPointSet
 
toString() - Method in class umontreal.iro.lecuyer.hups.ContainerPointSet
 
toString() - Method in class umontreal.iro.lecuyer.hups.CycleBasedPointSet
 
toString() - Method in class umontreal.iro.lecuyer.hups.DigitalNet
 
toString() - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2
 
toString() - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2FromFile
 
toString() - Method in class umontreal.iro.lecuyer.hups.DigitalNetFromFile
 
toString() - Method in class umontreal.iro.lecuyer.hups.F2wCycleBasedLFSR
 
toString() - Method in class umontreal.iro.lecuyer.hups.F2wCycleBasedPolyLCG
 
toString() - Method in class umontreal.iro.lecuyer.hups.F2wNetLFSR
 
toString() - Method in class umontreal.iro.lecuyer.hups.F2wNetPolyLCG
 
toString() - Method in class umontreal.iro.lecuyer.hups.F2wStructure
This method returns a string containing the polynomial P(z) and the stepping parameter.
toString() - Method in class umontreal.iro.lecuyer.hups.FaureSequence
 
toString() - Method in class umontreal.iro.lecuyer.hups.KorobovLattice
 
toString() - Method in class umontreal.iro.lecuyer.hups.LCGPointSet
 
toString() - Method in class umontreal.iro.lecuyer.hups.NiedSequenceBase2
 
toString() - Method in class umontreal.iro.lecuyer.hups.NiedXingSequenceBase2
 
toString() - Method in class umontreal.iro.lecuyer.hups.PaddedPointSet
 
toString() - Method in class umontreal.iro.lecuyer.hups.PointSet
Formats a string that contains information about the point set.
toString() - Method in class umontreal.iro.lecuyer.hups.RandShiftedPointSet
 
toString() - Method in class umontreal.iro.lecuyer.hups.Rank1Lattice
 
toString() - Method in class umontreal.iro.lecuyer.hups.SobolSequence
 
toString() - Method in class umontreal.iro.lecuyer.hups.SubsetOfPointSet
 
toString() - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.AndersonDarlingDistQuick
 
toString() - Method in class umontreal.iro.lecuyer.probdist.BernoulliDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.BetaDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.BetaSymmetricalDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.BinomialDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.CauchyDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.ChiDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.ChiSquareNoncentralDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.CramerVonMisesDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.DiscreteDistribution
Returns a String containing information about the current distribution.
toString() - Method in class umontreal.iro.lecuyer.probdist.EmpiricalDist
Returns a String containing information about the current distribution.
toString() - Method in class umontreal.iro.lecuyer.probdist.ErlangDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.ExponentialDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.ExtremeValueDist
Deprecated.  
toString() - Method in class umontreal.iro.lecuyer.probdist.FatigueLifeDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.FisherFDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.FoldedNormalDist
Returns a String containing information about the current distribution.
toString() - Method in class umontreal.iro.lecuyer.probdist.FrechetDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.GammaDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.GeometricDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.GumbelDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.HalfNormalDist
Returns a String containing information about the current distribution.
toString() - Method in class umontreal.iro.lecuyer.probdist.HyperbolicSecantDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.HypergeometricDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.InverseDistFromDensity
Returns a String containing information about the current distribution.
toString() - Method in class umontreal.iro.lecuyer.probdist.InverseGammaDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.InverseGaussianDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSBDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.JohnsonSUDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.KolmogorovSmirnovPlusDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.LaplaceDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.LogarithmicDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.LogisticDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.LoglogisticDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.LognormalDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.NakagamiDist
Returns a String containing information about the current distribution.
toString() - Method in class umontreal.iro.lecuyer.probdist.NegativeBinomialDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.NormalDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.NormalInverseGaussianDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.ParetoDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.PascalDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.Pearson5Dist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.Pearson6Dist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.PiecewiseLinearEmpiricalDist
Returns a String containing information about the current distribution.
toString() - Method in class umontreal.iro.lecuyer.probdist.PoissonDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.PowerDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.RayleighDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.StudentDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.TriangularDist
Returns a String containing information about the current distribution.
toString() - Method in class umontreal.iro.lecuyer.probdist.TruncatedDist
Returns a String containing information about the current distribution.
toString() - Method in class umontreal.iro.lecuyer.probdist.UniformDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.UniformIntDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.WatsonGDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.WatsonUDist
 
toString() - Method in class umontreal.iro.lecuyer.probdist.WeibullDist
 
toString() - Method in class umontreal.iro.lecuyer.randvar.RandomVariateGen
Returns a String containing information about the current generator.
toString() - Method in class umontreal.iro.lecuyer.randvarmulti.IIDMultivariateGen
Returns a string representation of the generator.
toString() - Method in class umontreal.iro.lecuyer.rng.AntitheticStream
Returns a string starting with "Antithetic of " and finishing with the result of the call to the toString method of the generator.
toString() - Method in class umontreal.iro.lecuyer.rng.BakerTransformedStream
Returns a string starting with "Baker transformation of " and finishing with the result of the call to the toString method of the generator.
toString() - Method in class umontreal.iro.lecuyer.rng.BasicRandomStreamFactory
 
toString() - Method in class umontreal.iro.lecuyer.rng.F2NL607
 
toString() - Method in class umontreal.iro.lecuyer.rng.GenF2w32
 
toString() - Method in class umontreal.iro.lecuyer.rng.LFSR113
 
toString() - Method in class umontreal.iro.lecuyer.rng.LFSR258
 
toString() - Method in class umontreal.iro.lecuyer.rng.MRG31k3p
 
toString() - Method in class umontreal.iro.lecuyer.rng.MRG32k3a
Returns a string containing the name and the current state Cg of this stream.
toString() - Method in class umontreal.iro.lecuyer.rng.MRG32k3aL
 
toString() - Method in class umontreal.iro.lecuyer.rng.MT19937
 
toString() - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated.  
toString() - Method in interface umontreal.iro.lecuyer.rng.RandomStream
Returns a string containing the current state of this stream.
toString() - Method in class umontreal.iro.lecuyer.rng.RandomStreamBase
 
toString() - Method in exception umontreal.iro.lecuyer.rng.RandomStreamInstantiationException
Returns a short description of the exception.
toString() - Method in class umontreal.iro.lecuyer.rng.RandomStreamManager
 
toString() - Method in class umontreal.iro.lecuyer.rng.RandRijndael
 
toString() - Method in class umontreal.iro.lecuyer.rng.WELL1024
 
toString() - Method in class umontreal.iro.lecuyer.rng.WELL512
 
toString() - Method in class umontreal.iro.lecuyer.rng.WELL607
 
toString() - Method in class umontreal.iro.lecuyer.simevents.eventlist.BinaryTree
 
toString() - Method in class umontreal.iro.lecuyer.simevents.eventlist.DoublyLinked
 
toString() - Method in class umontreal.iro.lecuyer.simevents.eventlist.Henriksen
 
toString() - Method in class umontreal.iro.lecuyer.simevents.eventlist.RedblackTree
 
toString() - Method in class umontreal.iro.lecuyer.simevents.eventlist.SplayTree
 
toString() - Method in class umontreal.iro.lecuyer.simevents.ListWithStat.Node
 
toString() - Method in class umontreal.iro.lecuyer.stat.TallyStore
Returns the observations stored in this object as a String.
toString() - Method in class umontreal.iro.lecuyer.util.BitMatrix
Creates a String containing all the data of the BitMatrix.
toString() - Method in class umontreal.iro.lecuyer.util.BitVector
Returns a string containing all the bits of the BitVector, starting with the highest order bit and finishing with the lowest order bit.
toString(double[][]) - Static method in class umontreal.iro.lecuyer.util.DMatrix
Returns matrix M as a string.
toString() - Method in class umontreal.iro.lecuyer.util.DMatrix
Creates a String containing all the data of the DMatrix.
toString() - Method in class umontreal.iro.lecuyer.util.PrintfFormat
Converts the buffer into a String.
toString() - Method in enum umontreal.iro.lecuyer.util.TimeUnit
Calls getLongName.
toStringByValue() - Method in class cern.colt.map.AbstractDoubleIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.AbstractIntDoubleMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.AbstractIntIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.AbstractIntObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value, according to natural ordering.
toStringByValue() - Method in class cern.colt.map.AbstractLongObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value, according to natural ordering.
toStringByValue() - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tint.AbstractIntIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tlong.AbstractIntLongMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tlong.AbstractLongIntMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tlong.AbstractLongLongMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value.
toStringByValue() - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value, according to natural ordering.
toStringByValue() - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Returns a string representation of the receiver, containing the String representation of each key-value pair, sorted ascending by value, according to natural ordering.
toStringDetailed() - Method in class umontreal.iro.lecuyer.hups.DigitalNetBase2FromFile
Writes the parameters and the generating matrices of this digital net to a string.
toStringDetailed() - Method in class umontreal.iro.lecuyer.hups.DigitalNetFromFile
Writes the parameters and the generating matrices of this digital net to a string.
toStringFull() - Method in class umontreal.iro.lecuyer.rng.MRG32k3a
Returns a string containing the name of this stream and the values of all its internal variables.
toStringFull() - Method in class umontreal.iro.lecuyer.rng.MRG32k3aL
 
toStringFull() - Method in class umontreal.iro.lecuyer.rng.RandMrg
Deprecated. Returns a string containing the name of this stream and the values of all its internal variables.
toStringShort() - Method in class cern.colt.matrix.AbstractMatrix1D
Returns a string representation of the receiver's shape.
toStringShort() - Method in class cern.colt.matrix.AbstractMatrix2D
Returns a string representation of the receiver's shape.
toStringShort() - Method in class cern.colt.matrix.AbstractMatrix3D
Returns a string representation of the receiver's shape.
toStringShort() - Method in class cern.colt.matrix.impl.AbstractMatrix1D
Returns a string representation of the receiver's shape.
toStringShort() - Method in class cern.colt.matrix.impl.AbstractMatrix2D
Returns a string representation of the receiver's shape.
toStringShort() - Method in class cern.colt.matrix.impl.AbstractMatrix3D
Returns a string representation of the receiver's shape.
toTable() - Method in class jhplot.F1D
Print the F1D function to a Table in a separate Frame.
toTable(boolean) - Method in class jhplot.F1D
Print the F1D function to a Table in a separate Frame.
toTable() - Method in class jhplot.H1D
Print a H1D histogram to a Table in a separate frame.
toTable(boolean) - Method in class jhplot.H1D
Print the H1D histogram to a Table in a separate Frame.
toTable(boolean) - Method in class jhplot.HProf1D
Print the profile histogram to a Table in a separate Frame.
toTable() - Method in class jhplot.P0D
Print the P0D container to a Table in a separate Frame.
toTable(boolean) - Method in class jhplot.P0D
Print the P0D array to a Table in a separate Frame.
toTable() - Method in class jhplot.P0I
Print the P0I container to a Table in a separate Frame.
toTable(boolean) - Method in class jhplot.P0I
Print the P0I array to a Table in a separate Frame.
toTable() - Method in class jhplot.P1D
Print the P1D container to a Table in a separate Frame.
toTable(boolean) - Method in class jhplot.P1D
Print the P1D container to a Table in a separate Frame.
toTable() - Method in class jhplot.P2D
Print the P2D container to a Table in a separate Frame.
toTable(boolean) - Method in class jhplot.P2D
Print the P2D container to a Table in a separate Frame.
toTable() - Method in class jhplot.P3D
Print the P2D container to a Table in a separate Frame.
toTable(boolean) - Method in class jhplot.P3D
Print the P2D container to a Table in a separate Frame.
totalMemory() - Method in interface cern.jet.stat.quantile.DoubleQuantileFinder
Returns the number of elements currently needed to store all contained elements.
totalMemory() - Method in interface cern.jet.stat.tdouble.quantile.DoubleQuantileFinder
Returns the number of elements currently needed to store all contained elements.
totalMemory() - Method in class cern.jet.stat.tdouble.quantile.ExactDoubleQuantileFinder
Returns the number of elements currently needed to store all contained elements.
totalMemory() - Method in interface cern.jet.stat.tfloat.quantile.FloatQuantileFinder
Returns the number of elements currently needed to store all contained elements.
totalProbesSaved - Variable in class cern.colt.map.tint.QuickOpenIntIntHashMap
 
toTitleString(DoubleMatrix2D, String[], String[], String, String, String, BinFunction1D[]) - Method in class cern.colt.matrix.doublealgo.Formatter
Same as toTitleString except that additionally statistical aggregates (mean, median, sum, etc.) of rows and columns are printed.
toTitleString(DoubleMatrix3D, String[], String[], String[], String, String, String, String, BinFunction1D[]) - Method in class cern.colt.matrix.doublealgo.Formatter
Returns a string representation of the given matrix with axis as well as rows and columns labeled.
toTitleString(ObjectMatrix2D, String[], String[], String, String, String) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string representation of the given matrix with axis as well as rows and columns labeled.
toTitleString(ObjectMatrix3D, String[], String[], String[], String, String, String, String) - Method in class cern.colt.matrix.objectalgo.Formatter
Returns a string representation of the given matrix with axis as well as rows and columns labeled.
toTitleString(DoubleMatrix2D, String[], String[], String, String, String, DoubleBinFunction1D[]) - Method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Same as toTitleString except that additionally statistical aggregates (mean, median, sum, etc.) of rows and columns are printed.
toTitleString(DoubleMatrix3D, String[], String[], String[], String, String, String, String, DoubleBinFunction1D[]) - Method in class cern.colt.matrix.tdouble.algo.DoubleFormatter
Returns a string representation of the given matrix with axis as well as rows and columns labeled.
toTitleString(FloatMatrix2D, String[], String[], String, String, String, FloatBinFunction1D[]) - Method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Same as toTitleString except that additionally statistical aggregates (mean, median, sum, etc.) of rows and columns are printed.
toTitleString(FloatMatrix3D, String[], String[], String[], String, String, String, String, FloatBinFunction1D[]) - Method in class cern.colt.matrix.tfloat.algo.FloatFormatter
Returns a string representation of the given matrix with axis as well as rows and columns labeled.
toTitleString(ObjectMatrix2D, String[], String[], String, String, String) - Method in class cern.colt.matrix.tobject.algo.ObjectFormatter
Returns a string representation of the given matrix with axis as well as rows and columns labeled.
toTitleString(ObjectMatrix3D, String[], String[], String[], String, String, String, String) - Method in class cern.colt.matrix.tobject.algo.ObjectFormatter
Returns a string representation of the given matrix with axis as well as rows and columns labeled.
TournamentSelection - Class in org.apache.commons.math.genetics
Tournament selection scheme.
TournamentSelection(int) - Constructor for class org.apache.commons.math.genetics.TournamentSelection
Creates a new TournamentSelection instance.
toUserX(int) - Method in class jhplot.jadraw.JaAxes
Move to User coordinates
toUserY(int) - Method in class jhplot.jadraw.JaAxes
Move to User coordinates
toVerboseString(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the results of toString(A) and additionally the results of all sorts of decompositions applied to the given matrix.
toVerboseString(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the results of toString(A) and additionally the results of all sorts of decompositions applied to the given matrix.
toVerboseString(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the results of toString(A) and additionally the results of all sorts of decompositions applied to the given matrix.
toX(double) - Method in class jhplot.HPlot
Convert the user coordinate X to the pixel coordinate
toX(double) - Method in class jhplot.jadraw.JaAxes
Convert the user coordinate X to the pixel coordinate
toXML(IHistogram1D) - Method in class cern.hep.aida.ref.Converter
Returns a XML representation of the given argument.
toXML(IHistogram2D) - Method in class cern.hep.aida.ref.Converter
Returns a XML representation of the given argument.
toXML(DoubleIHistogram1D) - Method in class hep.aida.tdouble.ref.DoubleConverter
Returns a XML representation of the given argument.
toXML(DoubleIHistogram2D) - Method in class hep.aida.tdouble.ref.DoubleConverter
Returns a XML representation of the given argument.
toXML(FloatIHistogram1D) - Method in class hep.aida.tfloat.ref.FloatConverter
Returns a XML representation of the given argument.
toXML(FloatIHistogram2D) - Method in class hep.aida.tfloat.ref.FloatConverter
Returns a XML representation of the given argument.
toXML(Object) - Static method in class jhplot.io.Serialized
Convert object to XML using XSream package
toY(double) - Method in class jhplot.HPlot
Convert the user coordinate Y to the pixel coordinate
toY(double) - Method in class jhplot.jadraw.JaAxes
Convert the user coordinate Y to the pixel coordinate
trace(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Returns the sum of the diagonal elements of matrix A; Sum(A[i,i]).
trace(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the sum of the diagonal elements of matrix A; Sum(A[i,i]).
trace(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the sum of the diagonal elements of matrix A; Sum(A[i,i]).
trace() - Method in class flanagan.math.Matrix
 
trace(Matrix) - Static method in class flanagan.math.Matrix
 
trace() - Method in class hephysics.vec.Hep3Matrix
Returns the trace of the matrix.
trace(double[][]) - Static method in class jhplot.math.LinearAlgebra
 
trainBackpopogation(boolean, int, double, double, double) - Method in class jhplot.HNeuralNet
Training neural network.Construct a backpropagation trainer.
TRandomVariable - Class in jhplot.math.num.random
A random variable generator for Student's t distribution.
TRandomVariable() - Constructor for class jhplot.math.num.random.TRandomVariable
Default constructor.
TRandomVariable(double) - Constructor for class jhplot.math.num.random.TRandomVariable
Create a random variable with the given degrees of freedom.
TRandomVariable(double, RNG) - Constructor for class jhplot.math.num.random.TRandomVariable
Create a random variable with the given parameters.
transApply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleAMG
 
transApply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleDiagonal
 
transApply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleICC
 
transApply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleIdentity
 
transApply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleILU
 
transApply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleILUT
 
transApply(DoubleMatrix1D, DoubleMatrix1D) - Method in interface cern.colt.matrix.tdouble.algo.solver.preconditioner.DoublePreconditioner
Solves the approximate transpose problem with the given right hand side.
transApply(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.solver.preconditioner.DoubleSSOR
 
transApply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatAMG
 
transApply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatDiagonal
 
transApply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatICC
 
transApply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatIdentity
 
transApply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatILU
 
transApply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatILUT
 
transApply(FloatMatrix1D, FloatMatrix1D) - Method in interface cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatPreconditioner
Solves the approximate transpose problem with the given right hand side.
transApply(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.solver.preconditioner.FloatSSOR
 
transfiguration() - Method in class flanagan.math.TimeAndDate
 
transfiguration(int) - Method in class flanagan.math.TimeAndDate
 
Transform - Class in cern.colt.matrix.doublealgo
Deprecated.  
transform - Static variable in class cern.colt.matrix.doublealgo.Transform
Deprecated. Little trick to allow for "aliasing", that is, renaming this class.
transform() - Method in class flanagan.math.FourierTransform
 
transform(double[]) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Transform the given real data set.
transform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Transform the given real function, sampled on the given interval.
transform(double[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given real data set.
transform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given real function, sampled on the given interval.
transform(Complex[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given complex data set.
transform(double[]) - Method in class org.apache.commons.math.transform.FastHadamardTransformer
Transform the given real data set.
transform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastHadamardTransformer
Transform the given real function, sampled on the given interval.
transform(int[]) - Method in class org.apache.commons.math.transform.FastHadamardTransformer
Transform the given real data set.
transform(double[]) - Method in class org.apache.commons.math.transform.FastSineTransformer
Transform the given real data set.
transform(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastSineTransformer
Transform the given real function, sampled on the given interval.
transform(double[]) - Method in interface org.apache.commons.math.transform.RealTransformer
Transform the given real data set.
transform(UnivariateRealFunction, double, double, int) - Method in interface org.apache.commons.math.transform.RealTransformer
Transform the given real function, sampled on the given interval.
transform(Object) - Method in class org.apache.commons.math.util.DefaultTransformer
 
transform(Object) - Method in interface org.apache.commons.math.util.NumberTransformer
Implementing this interface provides a facility to transform from Object to Double.
transform(Object) - Method in class org.apache.commons.math.util.TransformerMap
Attempts to transform the Object against the map of NumberTransformers.
transform2(double[]) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Transform the given real data set.
transform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastCosineTransformer
Transform the given real function, sampled on the given interval.
transform2(double[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given real data set.
transform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given real function, sampled on the given interval.
transform2(Complex[]) - Method in class org.apache.commons.math.transform.FastFourierTransformer
Transform the given complex data set.
transform2(double[]) - Method in class org.apache.commons.math.transform.FastSineTransformer
Transform the given real data set.
transform2(UnivariateRealFunction, double, double, int) - Method in class org.apache.commons.math.transform.FastSineTransformer
Transform the given real function, sampled on the given interval.
transformedCorrelationCoefficient() - Method in class flanagan.analysis.BoxCox
 
transformedData() - Method in class flanagan.analysis.BoxCox
 
transformedExcessKurtosis() - Method in class flanagan.analysis.BoxCox
 
transformedGradient() - Method in class flanagan.analysis.BoxCox
 
transformedIntercept() - Method in class flanagan.analysis.BoxCox
 
transformedMaximum() - Method in class flanagan.analysis.BoxCox
 
transformedMean() - Method in class flanagan.analysis.BoxCox
 
transformedMedian() - Method in class flanagan.analysis.BoxCox
 
transformedMedianSkewness() - Method in class flanagan.analysis.BoxCox
 
transformedMinimum() - Method in class flanagan.analysis.BoxCox
 
transformedMomentSkewness() - Method in class flanagan.analysis.BoxCox
 
transformedProbabilityPlot() - Method in class flanagan.analysis.BoxCox
 
transformedQuartileSkewness() - Method in class flanagan.analysis.BoxCox
 
transformedRange() - Method in class flanagan.analysis.BoxCox
 
transformedStandardDeviation() - Method in class flanagan.analysis.BoxCox
 
transformedStandardError() - Method in class flanagan.analysis.BoxCox
 
transformedVariance() - Method in class flanagan.analysis.BoxCox
 
TransformerMap - Class in org.apache.commons.math.util
This TansformerMap automates the transformation of mixed object types.
TransformerMap() - Constructor for class org.apache.commons.math.util.TransformerMap
Build a map containing only the default transformer.
transformers() - Method in class org.apache.commons.math.util.TransformerMap
Returns the Set of NumberTransformers used as values in the map.
TransformingList<OE,IE> - Class in umontreal.iro.lecuyer.util
Represents a list that dynamically transforms the elements of another list.
TransformingList(List<IE>) - Constructor for class umontreal.iro.lecuyer.util.TransformingList
Creates a new transforming list wrapping the inner list fromList.
translate(String) - Method in class hep.aida.ref.function.JELCompiledExpression.Resolver
 
translate(String) - Method in class hep.aida.ref.tuple.JELTupleProvider
 
transpose(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Algebra
Constructs and returns a new view which is the transposition of the given matrix A.
transpose(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Constructs and returns a new view which is the transposition of the given matrix A.
transpose(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Constructs and returns a new view which is the transposition of the given matrix A.
Transpose - Enum in cern.colt.matrix
Transpose enumeration
transpose() - Method in class flanagan.math.Matrix
 
transpose(Matrix) - Static method in class flanagan.math.Matrix
 
transpose() - Method in class hephysics.matrix.BasicMatrix
 
transpose() - Method in interface hephysics.matrix.MutableMatrix
Tranpose this matrix (into itself)
transpose() - Method in class hephysics.matrix.SymmetricMatrix
 
transpose() - Method in class hephysics.vec.Hep3Matrix
 
transpose() - Method in class jhplot.bsom.Matrix
Transpose: X'.
transpose(double[][]) - Static method in class jhplot.math.ArrayMathUtils
Takes the transpose of an array (like the matrix operation).
transpose(int[][]) - Static method in class jhplot.math.ArrayMathUtils
Takes the transpose of an array (like the matrix operation).
transpose(double[][]) - Static method in class jhplot.math.DoubleArray
Transposes an mxn matrix into an nxm matrix.
transpose() - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Returns the transpose of this matrix.
transpose() - Method in interface org.apache.commons.math.linear.BigMatrix
Deprecated. Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math.linear.BigMatrixImpl
Deprecated. Returns the transpose matrix.
transpose() - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Returns the transpose of this matrix.
transpose() - Method in class org.apache.commons.math.linear.BlockRealMatrix
Returns the transpose of this matrix.
transpose() - Method in interface org.apache.commons.math.linear.FieldMatrix
Returns the transpose of this matrix.
transpose() - Method in interface org.apache.commons.math.linear.RealMatrix
Returns the transpose of this matrix.
transpose() - Method in class umontreal.iro.lecuyer.util.BitMatrix
Returns the transposed matrix.
transpose() - Method in class umontreal.iro.lecuyer.util.DMatrix
Returns the transposed matrix.
transposed(Matrix, MutableMatrix) - Static method in class hephysics.matrix.MatrixOp
Traspose matrix mIn and write it to matrix mOut.
transposeMatrix(double[][]) - Static method in class flanagan.analysis.PCA
 
trapezium() - Method in class flanagan.integration.Integration
 
trapezium(int) - Method in class flanagan.integration.Integration
 
trapezium(IntegralFunction, double, double, int) - Static method in class flanagan.integration.Integration
 
trapezium(double, int) - Method in class flanagan.integration.Integration
 
trapezium(IntegralFunction, double, double, double, int) - Static method in class flanagan.integration.Integration
 
trapezium(int, F1D, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using the trapezium rule.
trapezium2D(int, F2D, double, double, double, double) - Static method in class jhplot.math.Numeric
Numerical integration using the trapezium rule.
TrapezoidalIntegrator - Class in jhplot.math.num.integration
The extended trapezoidal rule for numerically integrating functions.
TrapezoidalIntegrator(Function) - Constructor for class jhplot.math.num.integration.TrapezoidalIntegrator
Create an integrator for the given function.
TrapezoidalIntegrator(Function, int, double) - Constructor for class jhplot.math.num.integration.TrapezoidalIntegrator
Create an integrator for the given function.
trapezoidalLower(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Modifies the matrix to be a lower trapezoidal matrix.
trapezoidalLower(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Modifies the matrix to be a lower trapezoidal matrix.
TrapezoidIntegrator - Class in org.apache.commons.math.analysis.integration
Implements the Trapezoidal Rule for integration of real univariate functions.
TrapezoidIntegrator(UnivariateRealFunction) - Constructor for class org.apache.commons.math.analysis.integration.TrapezoidIntegrator
Deprecated. as of 2.0 the integrand function is passed as an argument to the TrapezoidIntegrator.integrate(UnivariateRealFunction, double, double)method.
TrapezoidIntegrator() - Constructor for class org.apache.commons.math.analysis.integration.TrapezoidIntegrator
Construct an integrator.
Tree - Class in hep.aida.ref.tree
 
TREE_CLOSED - Static variable in class hep.aida.ref.event.TreeEvent
 
TreeEvent - Class in hep.aida.ref.event
 
TreeEvent(Object, int, String[], Class, int) - Constructor for class hep.aida.ref.event.TreeEvent
 
TreeEvent(Object, int, String[], Class, String[]) - Constructor for class hep.aida.ref.event.TreeEvent
 
treeF() - Method in class jhplot.HPlot
Return TreeFactory associated with the plot
treeF() - Method in class jhplot.HPlotJa
Return TreeFactory associated with the plot
TreeFactory - Class in hep.aida.ref.tree
 
TreeFactory(IAnalysisFactory) - Constructor for class hep.aida.ref.tree.TreeFactory
The default constructor.
TreeFolderDoesNotExistException - Exception in hep.aida.ref.tree
 
TreeFolderDoesNotExistException() - Constructor for exception hep.aida.ref.tree.TreeFolderDoesNotExistException
Creates a new instance of TreeObjectAlreadyExistException
TreeFolderDoesNotExistException(String) - Constructor for exception hep.aida.ref.tree.TreeFolderDoesNotExistException
 
TreeObjectAlreadyExistException - Exception in hep.aida.ref.tree
 
TreeObjectAlreadyExistException() - Constructor for exception hep.aida.ref.tree.TreeObjectAlreadyExistException
Creates a new instance of TreeObjectAlreadyExistException
TreeObjectAlreadyExistException(String) - Constructor for exception hep.aida.ref.tree.TreeObjectAlreadyExistException
 
triangular(double, double) - Static method in class jhplot.math.Random
Generate a random number from a symetric triangular random variable.
triangular(double, double, double) - Static method in class jhplot.math.Random
Generate a random number from a non-symetric triangular random variable.
TriangularDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the triangular distribution with domain [a, b] and mode (or shape parameter) m, where a <= m <= b.
TriangularDist() - Constructor for class umontreal.iro.lecuyer.probdist.TriangularDist
Constructs a TriangularDist object with default parameters a = 0, b = 1, and m = 0.5.
TriangularDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.TriangularDist
Constructs a TriangularDist object with parameters a = 0 , b = 1 and m = m.
TriangularDist(double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.TriangularDist
Constructs a TriangularDist object with parameters a, b and m.
TriangularGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the triangular distribution.
TriangularGen(RandomStream, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.TriangularGen
Creates a triangular random variate generator over the interval (a, b), with parameter m, using stream s.
TriangularGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.TriangularGen
Creates a triangular random variate generator over the interval (0, 1), with parameter m, using stream s.
TriangularGen(RandomStream, TriangularDist) - Constructor for class umontreal.iro.lecuyer.randvar.TriangularGen
Creates a new generator for the triangular distribution dist and stream s.
TriCubicSpline - Class in flanagan.interpolation
 
TriCubicSpline(double[], double[], double[], double[][][]) - Constructor for class flanagan.interpolation.TriCubicSpline
 
TriCubicSpline(int, int, int) - Constructor for class flanagan.interpolation.TriCubicSpline
 
TricubicSplineInterpolatingFunction - Class in org.apache.commons.math.analysis.interpolation
Function that implements the tricubic spline interpolation, as proposed in Tricubic interpolation in three dimensions
F.
TricubicSplineInterpolatingFunction(double[], double[], double[], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][], double[][][]) - Constructor for class org.apache.commons.math.analysis.interpolation.TricubicSplineInterpolatingFunction
 
TricubicSplineInterpolator - Class in org.apache.commons.math.analysis.interpolation
Generates a tricubic interpolating function.
TricubicSplineInterpolator() - Constructor for class org.apache.commons.math.analysis.interpolation.TricubicSplineInterpolator
 
trigamma(double) - Static method in class org.apache.commons.math.special.Gamma
Computes the trigamma function of x.
trigamma(double) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the value of the trigamma function (x)/dx, the derivative of the digamma function, evaluated at x.
Trigonometric - Class in jhplot.math.num.special
Utility class that provides methods related to the trigonometric functions.
trim(int, int) - Method in class cern.hep.aida.bin.DynamicBin1D
Removes the s smallest and l largest elements from the receiver.
trim(int, int) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Removes the s smallest and l largest elements from the receiver.
trim(int, int) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Removes the s smallest and l largest elements from the receiver.
trimmedMean(int, int) - Method in class cern.hep.aida.bin.DynamicBin1D
Returns the trimmed mean.
trimmedMean(DoubleArrayList, double, int, int) - Static method in class cern.jet.stat.Descriptive
Returns the trimmed mean of a sorted data sequence.
trimmedMean(DoubleArrayList, double, int, int) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the trimmed mean of a sorted data sequence.
trimmedMean(FloatArrayList, float, int, int) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the trimmed mean of a sorted data sequence.
trimmedMean(int, int) - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Returns the trimmed mean.
trimmedMean(int, int) - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Returns the trimmed mean.
trimToCapacity(byte[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(char[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(double[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(float[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(int[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(long[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(Object[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(short[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToCapacity(boolean[], int) - Static method in class cern.colt.Arrays
Ensures that the specified array cannot hold more than maxCapacity elements.
trimToSize() - Method in class cern.colt.list.AbstractList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.BooleanArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.ByteArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.CharArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.DistinctNumberList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.DoubleArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.FloatArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.IntArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.LongArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.MinMaxNumberList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.ObjectArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.ShortArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.SimpleLongArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tboolean.BooleanArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tbyte.ByteArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tchar.CharArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tdouble.DoubleArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tfloat.FloatArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tint.IntArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tlong.DistinctNumberList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tlong.LongArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tlong.MinMaxNumberList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tlong.SimpleLongArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tobject.ObjectArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.list.tshort.ShortArrayList
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.AbstractMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.OpenDoubleIntHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.OpenIntDoubleHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.OpenIntIntHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.OpenIntObjectHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.OpenLongObjectHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tint.OpenIntIntHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.colt.matrix.AbstractMatrix
Releases any superfluous internal memory.
trimToSize() - Method in class cern.colt.matrix.impl.AbstractMatrix
Releases any superfluous internal memory.
trimToSize() - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix1D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.impl.SparseDoubleMatrix3D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.impl.SparseObjectMatrix1D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.impl.SparseObjectMatrix2D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.impl.SparseObjectMatrix3D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCMDComplexMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCMDComplexMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tdouble.impl.SparseCCMDoubleMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix1D
 
trimToSize() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
trimToSize() - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tdouble.impl.SparseRCMDoubleMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCMFComplexMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCMFComplexMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tfloat.impl.SparseCCMFloatMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix1D
 
trimToSize() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
trimToSize() - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tfloat.impl.SparseRCMFloatMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tint.impl.SparseCCMIntMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix1D
 
trimToSize() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
trimToSize() - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tint.impl.SparseRCMIntMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tlong.impl.SparseCCMLongMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix1D
 
trimToSize() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
trimToSize() - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tlong.impl.SparseRCMLongMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tobject.impl.SparseCCMObjectMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tobject.impl.SparseCCObjectMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix1D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
Releases any superfluous memory created by explicitly putting zero values into cells formerly having non-zero values; An application can use this operation to minimize the storage of the receiver.
trimToSize() - Method in class cern.colt.matrix.tobject.impl.SparseRCMObjectMatrix2D
 
trimToSize() - Method in class cern.colt.matrix.tobject.impl.SparseRCObjectMatrix2D
 
trimToSize() - Method in class cern.hep.aida.bin.AbstractBin
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.hep.aida.bin.AbstractBin1D
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class cern.hep.aida.bin.DynamicBin1D
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class hep.aida.tdouble.bin.DynamicDoubleBin1D
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Trims the capacity of the receiver to be the receiver's current size.
trimToSize() - Method in class hep.aida.tfloat.bin.DynamicFloatBin1D
Trims the capacity of the receiver to be the receiver's current size.
trinitySunday() - Method in class flanagan.math.TimeAndDate
 
trinitySunday(int) - Method in class flanagan.math.TimeAndDate
 
triplePartition(double[], double[], double[], int, int, double[], int, int, int[]) - Static method in class cern.colt.Partitioning
Same as Partitioning.triplePartition(int[],int[],int[],int,int,int[],int,int,int[]) except that it synchronously partitions double[] rather than int[] arrays.
triplePartition(double[], double[], double[], int, int, double) - Static method in class cern.colt.Partitioning
Same as Partitioning.triplePartition(int[],int[],int[],int,int,int) except that it synchronously partitions double[] rather than int[] arrays.
triplePartition(int[], int[], int[], int, int, int[], int, int, int[]) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int[],int,int,int[]) except that this method synchronously partitions three arrays at the same time; all three arrays are partially sorted according to the elements of the primary array.
triplePartition(int[], int[], int[], int, int, int) - Static method in class cern.colt.Partitioning
Same as Partitioning.partition(int[],int,int,int) except that this method synchronously partitions three arrays at the same time; all three arrays are partially sorted according to the elements of the primary array.
TrivariateRealFunction - Interface in org.apache.commons.math.analysis
An interface representing a trivariate real function.
TrivariateRealGridInterpolator - Interface in org.apache.commons.math.analysis.interpolation
Interface representing a trivariate real interpolating function where the sample points must be specified on a regular grid.
trueSampleNumber() - Method in class flanagan.analysis.Stat
 
trueSampleNumber_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
trueSampleNumber_as_Complex() - Method in class flanagan.analysis.Stat
 
trueSampleNumber_as_double() - Method in class flanagan.analysis.Stat
 
trueSampleNumber_as_int() - Method in class flanagan.analysis.Stat
 
truncate(ErrorProp, int) - Static method in class flanagan.analysis.ErrorProp
 
truncate(int) - Method in class flanagan.analysis.ErrorProp
 
truncate(int) - Method in class flanagan.analysis.Stat
 
truncate(int) - Method in class flanagan.math.ArrayMaths
 
truncate(double, int) - Static method in class flanagan.math.Fmath
 
truncate(float, int) - Static method in class flanagan.math.Fmath
 
TruncatedDist - Class in umontreal.iro.lecuyer.probdist
This container class takes an arbitrary continuous distribution and truncates it to an interval [a, b], where a and b can be finite or infinite.
TruncatedDist(ContinuousDistribution, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.TruncatedDist
Constructs a new distribution by truncating distribution dist to the interval [a, b].
TruncatedRandomStream - Class in umontreal.iro.lecuyer.rng
Represents a container random stream generating numbers in an interval (a, b) instead of in (0, 1), where 0 <= a < b <= 1, by using the contained stream.
TruncatedRandomStream(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.rng.TruncatedRandomStream
 
tsallisEntropyNat(double) - Method in class flanagan.analysis.Stat
 
tsallisEntropyNat(double[], double) - Static method in class flanagan.analysis.Stat
 
tTest(double, double[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(double, double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(double, StatisticalSummary, double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(double, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(double[], double[], double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(double[], double[]) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(StatisticalSummary, StatisticalSummary, double) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
tTest(StatisticalSummary, StatisticalSummary) - Static method in class org.apache.commons.math.stat.inference.TestUtils
 
TTest - Interface in org.apache.commons.math.stat.inference
An interface for Student's t-tests.
tTest(double, double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the input array with the constant mu.
tTest(double, double[], double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which sample is drawn equals mu.
tTest(double, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the dataset described by sampleStats with the constant mu.
tTest(double, StatisticalSummary, double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which the dataset described by stats is drawn equals mu.
tTest(double[], double[]) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays.
tTest(double[], double[], double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha.
tTest(StatisticalSummary, StatisticalSummary) - Method in interface org.apache.commons.math.stat.inference.TTest
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances.
tTest(StatisticalSummary, StatisticalSummary, double) - Method in interface org.apache.commons.math.stat.inference.TTest
Performs a two-sided t-test evaluating the null hypothesis that sampleStats1 and sampleStats2 describe datasets drawn from populations with the same mean, with significance level alpha.
tTest(double, double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the input array with the constant mu.
tTest(double, double[], double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which sample is drawn equals mu.
tTest(double, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a one-sample, two-tailed t-test comparing the mean of the dataset described by sampleStats with the constant mu.
tTest(double, StatisticalSummary, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a two-sided t-test evaluating the null hypothesis that the mean of the population from which the dataset described by stats is drawn equals mu.
tTest(double[], double[]) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the input arrays.
tTest(double[], double[], double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a two-sided t-test evaluating the null hypothesis that sample1 and sample2 are drawn from populations with the same mean, with significance level alpha.
tTest(StatisticalSummary, StatisticalSummary) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Returns the observed significance level, or p-value, associated with a two-sample, two-tailed t-test comparing the means of the datasets described by two StatisticalSummary instances.
tTest(StatisticalSummary, StatisticalSummary, double) - Method in class org.apache.commons.math.stat.inference.TTestImpl
Performs a two-sided t-test evaluating the null hypothesis that sampleStats1 and sampleStats2 describe datasets drawn from populations with the same mean, with significance level alpha.
TTestImpl - Class in org.apache.commons.math.stat.inference
Implements t-test statistics defined in the TTest interface.
TTestImpl() - Constructor for class org.apache.commons.math.stat.inference.TTestImpl
Default constructor.
TTestImpl(TDistribution) - Constructor for class org.apache.commons.math.stat.inference.TTestImpl
Deprecated. in 2.2 (to be removed in 3.0).
tuple(int) - Method in class hep.aida.ref.tuple.AbstractTuple
 
tuple(int) - Method in interface hep.aida.ref.tuple.FTuple
 
tuple(int) - Method in class hep.aida.ref.tuple.FTupleAdapter
 
Tuple - Class in hep.aida.ref.tuple
 
Tuple(String, String, String[], Class[], String) - Constructor for class hep.aida.ref.tuple.Tuple
 
Tuple(String, String, String, String) - Constructor for class hep.aida.ref.tuple.Tuple
 
Tuple.TupleColumnFactory - Class in hep.aida.ref.tuple
 
Tuple.TupleColumnFactory() - Constructor for class hep.aida.ref.tuple.Tuple.TupleColumnFactory
 
TupleColumn - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnBoolean - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnByte - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnChar - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnDouble - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnFloat - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnFolder - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnInt - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnLong - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnObject - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnShort - Class in hep.aida.ref.tuple
 
TupleColumn.TupleColumnString - Class in hep.aida.ref.tuple
 
TupleCursor - Class in hep.aida.ref.tuple
 
TupleCursor(int, int, boolean) - Constructor for class hep.aida.ref.tuple.TupleCursor
 
TupleEvent - Class in hep.aida.ref.tuple
 
TupleEvent(Object) - Constructor for class hep.aida.ref.tuple.TupleEvent
 
TupleFactory - Class in hep.aida.ref.tuple
 
TupleFactory(ITree) - Constructor for class hep.aida.ref.tuple.TupleFactory
 
twelfthJuly() - Method in class flanagan.math.TimeAndDate
 
twelfthJuly(int) - Method in class flanagan.math.TimeAndDate
 
TWELVE - Static variable in class cern.colt.matrix.linalg.Property
A Property object with tolerance()==1.0E-12.
TWELVE - Static variable in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
A Property object with tolerance()==1.0E-12.
TWELVE - Static variable in class cern.colt.matrix.tdouble.algo.DoubleProperty
A Property object with tolerance()==1.0E-12.
TWO - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "2 / 1".
TWO - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "2 / 1".
TWO_FIFTHS - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "2/5".
TWO_FIFTHS - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "2/5".
TWO_PI - Static variable in class org.apache.commons.math.util.MathUtils
2 π.
TWO_QUARTERS - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "2/4".
TWO_QUARTERS - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "2/4".
TWO_THIRDS - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "2/3".
TWO_THIRDS - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "2/3".
twoBodyDecay(HEParticle, HEParticle, boolean) - Method in class hephysics.particle.HEParticle
Evaluates 4-vector of decay product in the rest frame of parent.
twoBodyDecay(LParticle, LParticle, boolean) - Method in class hephysics.particle.LParticle
Evaluates 4-vector of decay product in the rest frame of parent.
twoDarray(int, int) - Static method in class flanagan.analysis.ErrorProp
 
twoDarray(int, int, double, double) - Static method in class flanagan.analysis.ErrorProp
 
twoDarray(int, int, ErrorProp) - Static method in class flanagan.analysis.ErrorProp
 
twoDarray(int, int) - Static method in class jhplot.math.ValueErr
Create a two dimensional array of ValueErr objects of dimensions n and m with zeros
TWOEXP - Static variable in class umontreal.iro.lecuyer.util.Num
Contains the precomputed positive powers of 2.
twopi - Static variable in class cern.clhep.PhysicalConstants
 
twopi_mc2_rcl2 - Static variable in class cern.clhep.PhysicalConstants
 
type() - Method in class hep.aida.ref.function.Range
Get the IRange type.
type() - Method in class hep.aida.ref.GenericFactory
 
type() - Method in class hep.aida.ref.ManagedObject
 
type() - Method in class hep.aida.ref.tree.Folder
 
type() - Method in class hep.aida.ref.tree.Link
 
type() - Method in class hep.aida.ref.tree.MountPoint
 
type() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BaseTupleColumn
 
type() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ITupleTupleColumn
 
type() - Method in interface hep.aida.ref.tuple.FTupleColumn
 
type() - Method in class hep.aida.ref.tuple.TupleColumn
 
type - Variable in class umontreal.iro.lecuyer.charts.CustomHistogramDataset
The histogram type.
typeForClass(Class) - Static method in class hep.aida.ref.ManagedObject
 
typeIndex() - Method in class flanagan.math.ArrayMaths
 

U

ULP - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The FastMath.ulp method wrapped as a ComposableFunction.
ulp(double) - Static method in class org.apache.commons.math.util.FastMath
Compute least significant bit (Unit in Last Position) for a number.
ulp(float) - Static method in class org.apache.commons.math.util.FastMath
Compute least significant bit (Unit in Last Position) for a number.
umontreal.iro.lecuyer.charts - package umontreal.iro.lecuyer.charts
 
umontreal.iro.lecuyer.functionfit - package umontreal.iro.lecuyer.functionfit
 
umontreal.iro.lecuyer.functions - package umontreal.iro.lecuyer.functions
 
umontreal.iro.lecuyer.gof - package umontreal.iro.lecuyer.gof
 
umontreal.iro.lecuyer.hups - package umontreal.iro.lecuyer.hups
 
umontreal.iro.lecuyer.probdist - package umontreal.iro.lecuyer.probdist
 
umontreal.iro.lecuyer.probdistmulti - package umontreal.iro.lecuyer.probdistmulti
 
umontreal.iro.lecuyer.randvar - package umontreal.iro.lecuyer.randvar
 
umontreal.iro.lecuyer.randvarmulti - package umontreal.iro.lecuyer.randvarmulti
 
umontreal.iro.lecuyer.rng - package umontreal.iro.lecuyer.rng
 
umontreal.iro.lecuyer.simevents - package umontreal.iro.lecuyer.simevents
 
umontreal.iro.lecuyer.simevents.eventlist - package umontreal.iro.lecuyer.simevents.eventlist
 
umontreal.iro.lecuyer.simprocs - package umontreal.iro.lecuyer.simprocs
 
umontreal.iro.lecuyer.stat - package umontreal.iro.lecuyer.stat
 
umontreal.iro.lecuyer.stat.list - package umontreal.iro.lecuyer.stat.list
 
umontreal.iro.lecuyer.stochprocess - package umontreal.iro.lecuyer.stochprocess
 
umontreal.iro.lecuyer.util - package umontreal.iro.lecuyer.util
 
UnbinnedMaximumLikelihoodFitMethod - Class in hep.aida.ref.fitter.fitmethod
 
UnbinnedMaximumLikelihoodFitMethod() - Constructor for class hep.aida.ref.fitter.fitmethod.UnbinnedMaximumLikelihoodFitMethod
 
UnboundedSolutionException - Exception in org.apache.commons.math.optimization.linear
This class represents exceptions thrown by optimizers when a solution escapes to infinity.
UnboundedSolutionException() - Constructor for exception org.apache.commons.math.optimization.linear.UnboundedSolutionException
Simple constructor using a default message.
UncorrelatedRandomVectorGenerator - Class in org.apache.commons.math.random
A RandomVectorGenerator that generates vectors with uncorrelated components.
UncorrelatedRandomVectorGenerator(double[], double[], NormalizedRandomGenerator) - Constructor for class org.apache.commons.math.random.UncorrelatedRandomVectorGenerator
Simple constructor.
UncorrelatedRandomVectorGenerator(int, NormalizedRandomGenerator) - Constructor for class org.apache.commons.math.random.UncorrelatedRandomVectorGenerator
Simple constructor.
UNDERFLOW - Static variable in interface hep.aida.tdouble.DoubleIHistogram
Constant specifying the underflow bin (can be passed to any method expecting a bin number).
UNDERFLOW - Static variable in interface hep.aida.tfloat.FloatIHistogram
Constant specifying the underflow bin (can be passed to any method expecting a bin number).
unequal(Dfp) - Method in class org.apache.commons.math.dfp.Dfp
Check if instance is not equal to x.
UnfillableHistogramException - Exception in hep.aida.ref.histogram
Exception thrown if an IHistogram is unfillable.
UnfillableHistogramException() - Constructor for exception hep.aida.ref.histogram.UnfillableHistogramException
 
Uniform - Class in cern.jet.random
Uniform distribution; Math definition and animated definition.
Uniform(double, double, int) - Constructor for class cern.jet.random.Uniform
Constructs a uniform distribution with the given minimum and maximum, using a MersenneTwister seeded with the given seed.
Uniform(double, double, RandomEngine) - Constructor for class cern.jet.random.Uniform
Constructs a uniform distribution with the given minimum and maximum.
Uniform(RandomEngine) - Constructor for class cern.jet.random.Uniform
Constructs a uniform distribution with min=0.0 and max=1.0.
Uniform - Class in jhplot.math.num.pdf
The Uniform distribution (1).
Uniform() - Constructor for class jhplot.math.num.pdf.Uniform
Default constructor.
Uniform(double, double) - Constructor for class jhplot.math.num.pdf.Uniform
Create a distribution with the given lower bound and upper bound values.
uniform(double, double) - Static method in class jhplot.math.Random
Generate a random number from a uniform random variable.
UNIFORM_BOUNDS - Static variable in class jhplot.math.Slicing
 
UNIFORM_MODE - Static variable in class org.apache.commons.math.random.ValueServer
Uniform random deviates with mean = μ.
UniformDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the uniform distribution over the interval [a, b].
UniformDist() - Constructor for class umontreal.iro.lecuyer.probdist.UniformDist
Constructs a uniform distribution over the interval (a, b) = (0, 1).
UniformDist(double, double) - Constructor for class umontreal.iro.lecuyer.probdist.UniformDist
Constructs a uniform distribution over the interval (a, b).
UniformGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the (continuous) uniform distribution over the interval (a, b), where a and b are real numbers with a < b.
UniformGen(RandomStream, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.UniformGen
Creates a uniform random variate generator over the interval (a, b), using stream s.
UniformGen(RandomStream) - Constructor for class umontreal.iro.lecuyer.randvar.UniformGen
Creates a uniform random variate generator over the interval (0, 1), using stream s.
UniformGen(RandomStream, UniformDist) - Constructor for class umontreal.iro.lecuyer.randvar.UniformGen
Creates a new generator for the uniform distribution dist and stream s.
UniformIntDist - Class in umontreal.iro.lecuyer.probdist
Extends the class DiscreteDistributionInt for the discrete uniform distribution over the range [i, j].
UniformIntDist(int, int) - Constructor for class umontreal.iro.lecuyer.probdist.UniformIntDist
Constructs a discrete uniform distribution over the interval [i, j].
UniformIntGen - Class in umontreal.iro.lecuyer.randvar
This class implements a random variate generator for the uniform distribution over integers, over the interval [i, j].
UniformIntGen(RandomStream, int, int) - Constructor for class umontreal.iro.lecuyer.randvar.UniformIntGen
Creates a uniform random variate generator over the integers in the closed interval [i, j], using stream s.
UniformIntGen(RandomStream, UniformIntDist) - Constructor for class umontreal.iro.lecuyer.randvar.UniformIntGen
Creates a new generator for the distribution dist, using stream s.
uniformOrderStatisticMedians(int) - Static method in class flanagan.analysis.Stat
 
UniformRandomGenerator - Class in org.apache.commons.math.random
This class implements a normalized uniform random generator.
UniformRandomGenerator(RandomGenerator) - Constructor for class org.apache.commons.math.random.UniformRandomGenerator
Create a new generator.
UniformRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Uniform distribution.
UniformRandomVariable() - Constructor for class jhplot.math.num.random.UniformRandomVariable
Default constructor.
UniformRandomVariable(double, double) - Constructor for class jhplot.math.num.random.UniformRandomVariable
Create a random variable with the given lower bound and upper bound values.
UniformRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.UniformRandomVariable
Create a random variable with the given parameters.
unifTransform(DoubleArrayList, ContinuousDistribution) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Applies the transformation Ui = F(Vi) for i = 0, 1,…, N - 1, where F is a continuous distribution function, and returns the result as an array of length N.
unifTransform(DoubleArrayList, DiscreteDistribution) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Applies the transformation Ui = F(Vi) for i = 0, 1,…, N - 1, where F is a discrete distribution function, and returns the result as an array of length N.
uniqueIntegerArray(int, int) - Method in class flanagan.math.PsRandom
 
uniqueIntegerArray(int) - Method in class flanagan.math.PsRandom
 
unit(Hep3Vector) - Method in class hephysics.vec.Hep3Vector
returns (0,0,0) vector if input vector has length 0
unit(Hep3Vector) - Static method in class hephysics.vec.VecOp
returns (0,0,0) vector if input vector has length 0
unitize() - Method in class org.apache.commons.math.linear.AbstractRealVector
Converts this vector into a unit vector.
unitize() - Method in class org.apache.commons.math.linear.ArrayRealVector
Converts this vector into a unit vector.
unitize() - Method in class org.apache.commons.math.linear.OpenMapRealVector
Converts this vector into a unit vector.
unitize() - Method in interface org.apache.commons.math.linear.RealVector
Converts this vector into a unit vector.
unitMatrix(int) - Static method in class flanagan.math.Matrix
 
unitMatrix(int, int) - Static method in class flanagan.math.Matrix
 
Units - Class in cern.clhep
High Energy Physics coherent system of Units.
UnitSphereRandomVectorGenerator - Class in org.apache.commons.math.random
Generate random vectors isotropically located on the surface of a sphere.
UnitSphereRandomVectorGenerator(int, RandomGenerator) - Constructor for class org.apache.commons.math.random.UnitSphereRandomVectorGenerator
 
UnitSphereRandomVectorGenerator(int) - Constructor for class org.apache.commons.math.random.UnitSphereRandomVectorGenerator
Create an object that will use a default RNG (MersenneTwister), in order to generate the individual components.
unitVector() - Method in class org.apache.commons.math.linear.AbstractRealVector
Creates a unit vector pointing in the direction of this vector.
unitVector() - Method in class org.apache.commons.math.linear.ArrayRealVector
Creates a unit vector pointing in the direction of this vector.
unitVector() - Method in class org.apache.commons.math.linear.OpenMapRealVector
Creates a unit vector pointing in the direction of this vector.
unitVector() - Method in interface org.apache.commons.math.linear.RealVector
Creates a unit vector pointing in the direction of this vector.
UnivariateMatrixFunction - Interface in org.apache.commons.math.analysis
An interface representing a univariate matrix function.
UnivariateRealFunction - Interface in org.apache.commons.math.analysis
An interface representing a univariate real function.
UnivariateRealIntegrator - Interface in org.apache.commons.math.analysis.integration
Interface for univariate real integration algorithms.
UnivariateRealIntegratorImpl - Class in org.apache.commons.math.analysis.integration
Provide a default implementation for several generic functions.
UnivariateRealInterpolator - Interface in org.apache.commons.math.analysis.interpolation
Interface representing a univariate real interpolating function.
UnivariateRealOptimizer - Interface in org.apache.commons.math.optimization
Interface for (univariate real) optimization algorithms.
UnivariateRealSolver - Interface in org.apache.commons.math.analysis.solvers
Interface for (univariate real) rootfinding algorithms.
UnivariateRealSolverFactory - Class in org.apache.commons.math.analysis.solvers
Abstract factory class used to create UnivariateRealSolver instances.
UnivariateRealSolverFactoryImpl - Class in org.apache.commons.math.analysis.solvers
A concrete UnivariateRealSolverFactory.
UnivariateRealSolverFactoryImpl() - Constructor for class org.apache.commons.math.analysis.solvers.UnivariateRealSolverFactoryImpl
Default constructor.
UnivariateRealSolverImpl - Class in org.apache.commons.math.analysis.solvers
Deprecated. in 2.2 (to be removed in 3.0).
UnivariateRealSolverUtils - Class in org.apache.commons.math.analysis.solvers
Utility routines for UnivariateRealSolver objects.
UnivariateStatistic - Interface in org.apache.commons.math.stat.descriptive
Base interface implemented by all statistics.
UnivariateVectorialFunction - Interface in org.apache.commons.math.analysis
An interface representing a univariate vectorial function.
universe_mean_density - Static variable in class cern.clhep.PhysicalConstants
 
unknown_N_compute_B_and_K(double, double, int) - Static method in class cern.jet.stat.quantile.QuantileFinderFactory
Computes the number of buffers and number of values per buffer such that quantiles can be determined with an approximation error no more than epsilon with a certain probability.
unknown_N_compute_B_and_K(double, double, int) - Static method in class cern.jet.stat.tdouble.quantile.DoubleQuantileFinderFactory
Computes the number of buffers and number of values per buffer such that quantiles can be determined with an approximation error no more than epsilon with a certain probability.
unknown_N_compute_B_and_K(float, float, int) - Static method in class cern.jet.stat.tfloat.quantile.FloatQuantileFinderFactory
Computes the number of buffers and number of values per buffer such that quantiles can be determined with an approximation error no more than epsilon with a certain probability.
UnknownDistributionChiSquareTest - Interface in org.apache.commons.math.stat.inference
An interface for Chi-Square tests for unknown distributions.
unmount(String) - Method in class hep.aida.ref.tree.Tree
Unmount a subtree at a given path (mount point).
unrandomize() - Method in class umontreal.iro.lecuyer.hups.DigitalNet
 
unrandomize() - Method in class umontreal.iro.lecuyer.hups.PaddedPointSet
 
unrandomize() - Method in class umontreal.iro.lecuyer.hups.PointSet
By default, this method simply calls clearRandomShift().
UnuranContinuous - Class in umontreal.iro.lecuyer.randvar
This class permits one to create continuous univariate distribution using UNURAN via its string API.
UnuranContinuous(RandomStream, String) - Constructor for class umontreal.iro.lecuyer.randvar.UnuranContinuous
Same as UnuranContinuous(s, s, genStr).
UnuranContinuous(RandomStream, RandomStream, String) - Constructor for class umontreal.iro.lecuyer.randvar.UnuranContinuous
Constructs a new continuous random number generator using the UNURAN generator specification string genStr, main stream s, and auxiliary stream aux.
UnuranDiscreteInt - Class in umontreal.iro.lecuyer.randvar
This class permits one to create a discrete univariate distribution using UNURAN via its string API.
UnuranDiscreteInt(RandomStream, String) - Constructor for class umontreal.iro.lecuyer.randvar.UnuranDiscreteInt
Same as UnuranDiscreteInt (s, s, genStr).
UnuranDiscreteInt(RandomStream, RandomStream, String) - Constructor for class umontreal.iro.lecuyer.randvar.UnuranDiscreteInt
Constructs a new discrete random number generator using the UNURAN generator specification string genStr, main stream s, and auxiliary stream aux.
UnuranEmpirical - Class in umontreal.iro.lecuyer.randvar
This class permits one to create generators for empirical and quasi-empirical univariate distributions using UNURAN via its string interface.
UnuranEmpirical(RandomStream, String) - Constructor for class umontreal.iro.lecuyer.randvar.UnuranEmpirical
Constructs a new empirical univariate generator using the specification string genStr and stream s.
UnuranEmpirical(RandomStream, RandomStream, String) - Constructor for class umontreal.iro.lecuyer.randvar.UnuranEmpirical
Constructs a new empirical univariate generator using the specification string genStr, with main stream s and auxiliary stream aux.
UnuranEmpirical(RandomStream, PiecewiseLinearEmpiricalDist, String) - Constructor for class umontreal.iro.lecuyer.randvar.UnuranEmpirical
Same as UnuranEmpirical(s, s, dist, genStr).
UnuranEmpirical(RandomStream, RandomStream, PiecewiseLinearEmpiricalDist, String) - Constructor for class umontreal.iro.lecuyer.randvar.UnuranEmpirical
Same as UnuranEmpirical(s, aux, genStr), but reading the observations from the empirical distribution dist.
UnuranException - Exception in umontreal.iro.lecuyer.randvar
This type of unchecked exception is thrown when an error occurs inside the UNURAN package.
UnuranException() - Constructor for exception umontreal.iro.lecuyer.randvar.UnuranException
Constructs a new generic UNURAN exception.
UnuranException(String) - Constructor for exception umontreal.iro.lecuyer.randvar.UnuranException
Constructs a UNURAN exception with the error message message
unweightedRegression() - Method in class flanagan.analysis.ProbabilityPlot
 
update() - Method in class jhplot.HChart
Update all plots
update(int, int) - Method in class jhplot.HChart
Update the chart
update(int, int) - Method in class jhplot.HPlot
Refresh only a particular plot
update() - Method in class jhplot.HPlot
Just update the current plot selected using cd() method
update() - Method in class jhplot.HPlot2D
Update current canvas
update(int, int) - Method in class jhplot.HPlot3D
Refresh only a particular plot
update() - Method in class jhplot.HPlot3D
Update the graphics
update() - Method in class jhplot.HPlot3DP
Just update the current plot selected using cd() method
update() - Method in class jhplot.HPlotJa
Update the canvas by repainting all objects
update(int, int) - Method in class jhplot.HView3D
Refresh only a particular plot
update() - Method in class jhplot.HView3D
Just update the current plot selected using cd() method
update() - Method in class jhplot.HZirkel
Update the canvas with new objects.
update(Object, String) - Method in class jhplot.io.HDataBase
Update the database with a new value
update() - Method in class jhplot.SPlot
Repaint the plot and update all graphics.
update(Graphics) - Method in class jhplot.v3d.Animation
 
update(Graphics) - Method in class jhplot.v3d.Canvas3d
 
update() - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Updates the accumulator using the last value passed to update.
update(double) - Method in class umontreal.iro.lecuyer.simevents.Accumulate
Gives a new observation x to the statistical collector.
updateAll() - Method in class jhplot.HPlot
Refresh all the plots on the same canvas HPLOT
updateAll() - Method in class jhplot.HPlot3D
Refresh all the plots on the same canvas HPLOT
updateAll() - Method in class jhplot.HPlot3DP
Refresh all the plots on the same canvas HPLOT
updateAll() - Method in class jhplot.HView3D
Refresh all the plots on the same canvas HPLOT
updateCoor() - Method in class jhplot.jadraw.JaObject
 
updateData(int, int) - Method in class jhplot.HPlot3D
Update data on the plot
updateData() - Method in class jhplot.HPlot3D
Update data on the plot
updateDivideByRowVector(Matrix) - Method in class jhplot.bsom.Matrix
X_{ij} = X_{ij}/v_{j}.
updateExp() - Method in class jhplot.bsom.Matrix
Update by exponential : exp(X_{ij})
updateFrame() - Method in class jhplot.GHFrame
update frame UI
updateGraphIfShowing() - Method in class jhplot.HPlot
Update the graph if it is showing.
updateHighOrderDerivativesPhase1(Array2DRowRealMatrix) - Method in class org.apache.commons.math.ode.nonstiff.AdamsIntegrator
Update the high order scaled derivatives for Adams integrators (phase 1).
updateHighOrderDerivativesPhase1(Array2DRowRealMatrix) - Method in class org.apache.commons.math.ode.nonstiff.AdamsNordsieckTransformer
Update the high order scaled derivatives for Adams integrators (phase 1).
updateHighOrderDerivativesPhase2(double[], double[], Array2DRowRealMatrix) - Method in class org.apache.commons.math.ode.nonstiff.AdamsIntegrator
Update the high order scaled derivatives Adams integrators (phase 2).
updateHighOrderDerivativesPhase2(double[], double[], Array2DRowRealMatrix) - Method in class org.apache.commons.math.ode.nonstiff.AdamsNordsieckTransformer
Update the high order scaled derivatives Adams integrators (phase 2).
updateLinearConv(double, double, Matrix) - Method in class jhplot.bsom.Matrix
Update by Linear conversion: X = a*X + b*Y.
updateNDC() - Method in class jhplot.jadraw.JaObject
 
updateRecord(RecordWriter) - Method in class jhplot.io.BaseRecordsFile
Updates an existing record.
updateSettings(XMLRead) - Method in class jhplot.shapes.HShape
Update the current primitive with the settings.
updateSummary() - Method in class jhplot.P1D
Update summary of the data.
upperBandwidth(DoubleMatrix2D) - Method in class cern.colt.matrix.linalg.Property
The upper bandwidth of a square matrix A is the maximum j-i for which A[i,j] is nonzero and j > i.
upperBandwidth(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DoubleProperty
The upper bandwidth of a square matrix A is the maximum j-i for which A[i,j] is nonzero and j > i.
upperBandwidth(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.FloatProperty
The upper bandwidth of a square matrix A is the maximum j-i for which A[i,j] is nonzero and j > i.
upperBandwidth(IntMatrix2D) - Method in class cern.colt.matrix.tint.algo.IntProperty
The upper bandwidth of a square matrix A is the maximum j-i for which A[i,j] is nonzero and j > i.
upperBandwidth(LongMatrix2D) - Method in class cern.colt.matrix.tlong.algo.LongProperty
The upper bandwidth of a square matrix A is the maximum j-i for which A[i,j] is nonzero and j > i.
upperBound() - Method in class hep.aida.ref.fitter.FitParameterSettings
 
upperBound() - Method in class hep.aida.ref.function.Range
Get the upper bound.
upperBounds() - Method in class hep.aida.ref.function.RangeSet
 
upperCumulativeProbability(int) - Method in class org.apache.commons.math.distribution.HypergeometricDistributionImpl
For this distribution, X, this method returns P(X ≥ x).
upperEdge() - Method in class cern.hep.aida.ref.FixedAxis
 
upperEdge() - Method in class cern.hep.aida.ref.VariableAxis
 
upperEdge() - Method in class hep.aida.ref.histogram.Cloud1D
Get the Cloud's upper edge.
upperEdge() - Method in class hep.aida.ref.histogram.FixedAxis
Get the Axis upper edge.
upperEdge() - Method in class hep.aida.ref.histogram.VariableAxis
 
upperEdge() - Method in interface hep.aida.tdouble.DoubleIAxis
Upper axis edge.
upperEdge() - Method in class hep.aida.tdouble.ref.DoubleFixedAxis
 
upperEdge() - Method in class hep.aida.tdouble.ref.DoubleVariableAxis
 
upperEdge() - Method in interface hep.aida.tfloat.FloatIAxis
Upper axis edge.
upperEdge() - Method in class hep.aida.tfloat.ref.FloatFixedAxis
 
upperEdge() - Method in class hep.aida.tfloat.ref.FloatVariableAxis
 
upperEdgeWithMargin() - Method in class hep.aida.ref.histogram.Cloud1D
 
upperEdgeX() - Method in class hep.aida.ref.histogram.Cloud2D
Get the Cloud's x upper edge.
upperEdgeX() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's x upper edge.
upperEdgeXWithMargin() - Method in class hep.aida.ref.histogram.Cloud2D
 
upperEdgeXWithMargin() - Method in class hep.aida.ref.histogram.Cloud3D
 
upperEdgeY() - Method in class hep.aida.ref.histogram.Cloud2D
Get the Cloud's y upper edge.
upperEdgeY() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's y upper edge.
upperEdgeYWithMargin() - Method in class hep.aida.ref.histogram.Cloud2D
 
upperEdgeYWithMargin() - Method in class hep.aida.ref.histogram.Cloud3D
 
upperEdgeZ() - Method in class hep.aida.ref.histogram.Cloud3D
Get the Cloud's z upper edge.
upperEdgeZWithMargin() - Method in class hep.aida.ref.histogram.Cloud3D
 
upperExtent(int) - Method in class hep.aida.ref.histogram.DataPoint
Get the upper value for a give axis.
upperExtent(int) - Method in class hep.aida.ref.histogram.DataPointSet
 
upperOutliersAnscombe(double) - Method in class flanagan.analysis.Stat
 
upperOutliersAnscombe(BigDecimal) - Method in class flanagan.analysis.Stat
 
upperOutliersAnscombe(BigInteger) - Method in class flanagan.analysis.Stat
 
upperOutliersAnscombe(double[], double) - Static method in class flanagan.analysis.Stat
 
upperOutliersAnscombe(BigDecimal[], BigDecimal) - Static method in class flanagan.analysis.Stat
 
upperOutliersAnscombe(BigInteger[], BigInteger) - Static method in class flanagan.analysis.Stat
 
upperOutliersAnscombe_as_BigDecimal(BigDecimal) - Method in class flanagan.analysis.Stat
 
upperOutliersAnscombe_as_BigDecimal(BigInteger) - Method in class flanagan.analysis.Stat
 
upperOutliersAnscombe_as_double(double) - Method in class flanagan.analysis.Stat
 
upperOutliersAnscombeAsArrayList(double[], double) - Static method in class flanagan.analysis.Stat
 
upperOutliersAnscombeAsArrayList(BigDecimal[], BigDecimal) - Static method in class flanagan.analysis.Stat
 
upperOutliersAnscombeAsArrayList(BigInteger[], BigInteger) - Static method in class flanagan.analysis.Stat
 
upperOutliersAnscombeAsVector(double[], double) - Static method in class flanagan.analysis.Stat
 
upperOutliersAnscombeAsVector(BigDecimal[], BigDecimal) - Static method in class flanagan.analysis.Stat
 
upperOutliersAnscombeAsVector(BigInteger[], BigInteger) - Static method in class flanagan.analysis.Stat
 
UPSIDE_VARIANCE - Static variable in class org.apache.commons.math.stat.descriptive.moment.SemiVariance
The UPSIDE Direction is used to specify that the observations above the cutoff point will be used to calculate SemiVariance.
useCorrelationMatrix() - Method in class flanagan.analysis.PCA
 
useCovarianceMatrix() - Method in class flanagan.analysis.PCA
 
usedNumberOfItems() - Method in class flanagan.analysis.Scores
 
usedNumberOfPersons() - Method in class flanagan.analysis.Scores
 
usedresponsesAsRowPerPerson() - Method in class flanagan.analysis.Scores
 
usedScoresAsRowPerItem() - Method in class flanagan.analysis.Scores
 
usedScoresAsRowPerPerson() - Method in class flanagan.analysis.Scores
 
usedTotalNumberOfScores() - Method in class flanagan.analysis.Scores
 
useEffectiveN() - Method in class flanagan.analysis.Stat
 
useErrorColumnMean() - Method in class flanagan.analysis.RankAnalysis
 
useErrorRowMean() - Method in class flanagan.analysis.RankAnalysis
 
useFunctionGradient() - Method in class hep.aida.ref.fitter.Fitter
 
useGaussianDeviates() - Method in class flanagan.analysis.PCA
 
useNormalVarimax() - Method in class flanagan.analysis.PCA
 
useNumberOfTics(int) - Method in class jhplot.HPlot
Returns whether or not to use a fixed number of ticks.
USER_HOME - Static variable in class jhplot.HPlotJa
The current user's home directory.
USER_NAME - Static variable in class jhplot.HPlotJa
The current user.
useRawVarimax() - Method in class flanagan.analysis.PCA
 
UserFunction - Class in hep.aida.ref.function
 
UserFunction() - Constructor for class hep.aida.ref.function.UserFunction
 
UserFunction(String) - Constructor for class hep.aida.ref.function.UserFunction
 
UserFunction(String[], String[]) - Constructor for class hep.aida.ref.function.UserFunction
 
UserRecord - Class in umontreal.iro.lecuyer.simprocs
This class represents a record object to store information related to the request of a process for a Resource or for Bin tokens, or when a process waits for a Condition.
useStaticEffectiveN() - Static method in class flanagan.analysis.Stat
 
useStaticTrueN() - Static method in class flanagan.analysis.Stat
 
useTrueN() - Method in class flanagan.analysis.Stat
 
useUniformDeviates() - Method in class flanagan.analysis.PCA
 
Util - Class in jhplot.v3d
Various useful functions of general purpose.
Utils - Class in cern.jet.stat
Holds some utility methods shared by different quantile finding implementations.

V

v() - Method in class hephysics.vec.Hep3Vector
 
v() - Method in class hephysics.vec.SpacePoint
Returns the space point as a double array in its internal representation
v3() - Method in class hephysics.vec.HepLorentzVector
Get 3-vector
vabs() - Method in class jhplot.v3d.Vector3d
 
value() - Method in class cern.hep.aida.bin.AbstractBin
Returns value(0).
value(int) - Method in class cern.hep.aida.bin.AbstractBin
Returns a custom definable "value" measure; override this method if necessary.
value(String) - Method in class hep.aida.ref.Annotation
Retrieve the value for a given key.
value(int) - Method in class hep.aida.ref.Annotation
Get the value corresponding to the item in a given position in the Annotation.
value() - Method in class hep.aida.ref.fitter.fitdata.FitDataIterator
 
value(double[]) - Method in class hep.aida.ref.fitter.InternalFitFunction
 
value(double[]) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
value(double[]) - Method in class hep.aida.ref.function.AbstractIFunction
Provide value for your function here.
value(double[]) - Method in class hep.aida.ref.function.BaseModelFunction
 
value(double[]) - Method in class hep.aida.ref.function.NonParametricFunction
 
value(double[]) - Method in class hep.aida.ref.function.SumOfFunctions
 
value(double[]) - Method in class hep.aida.ref.function.UserFunction
 
value(int) - Method in class hep.aida.ref.histogram.Cloud1D
Get a given value from the Cloud.
value() - Method in class hep.aida.ref.histogram.Measurement
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.BooleanTupleColumn
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ByteTupleColumn
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.CharTupleColumn
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.DoubleTupleColumn
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.FloatTupleColumn
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.IntTupleColumn
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ITupleTupleColumn
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.LongTupleColumn
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ObjectTupleColumn
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.ShortTupleColumn
 
value() - Method in class hep.aida.ref.tuple.AbstractTuple.AbstractTupleColumnFactory.StringTupleColumn
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnBoolean
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnBoolean
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnByte
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnByte
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnChar
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnChar
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnDouble
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnDouble
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFloat
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFloat
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnFolder
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnInt
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnInt
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnLong
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnLong
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnObject
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnObject
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnShort
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnShort
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnString
 
value() - Method in class hep.aida.ref.tuple.TupleColumn.TupleColumnString
 
value(FTupleCursor, Value) - Method in class hep.aida.ref.tuple.TupleColumn
 
value(int, Value) - Method in class hep.aida.ref.tuple.TupleColumn
 
value() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns value(0).
value(int) - Method in class hep.aida.tdouble.bin.AbstractDoubleBin
Returns a custom definable "value" measure; override this method if necessary.
value() - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns value(0).
value(int) - Method in class hep.aida.tfloat.bin.AbstractFloatBin
Returns a custom definable "value" measure; override this method if necessary.
value(double[]) - Method in class jhplot.fit.BreitWigner
 
value(double[]) - Method in class jhplot.fit.Exponent
 
value(double[]) - Method in class jhplot.fit.Gauss
 
value(double[]) - Method in class jhplot.fit.Landau
 
value(double[]) - Method in class jhplot.fit.NegativeBinomial
Get value of this function
value(double[]) - Method in class jhplot.fit.P0
 
value(double[]) - Method in class jhplot.fit.P1
 
value(double[]) - Method in class jhplot.fit.P2
 
value(double[]) - Method in class jhplot.fit.P3
 
value(double[]) - Method in class jhplot.fit.P4
 
value(double[]) - Method in class jhplot.fit.P5
 
value(double[]) - Method in class jhplot.fit.P6
 
value(double[]) - Method in class jhplot.fit.Poisson
 
value(double[]) - Method in class jhplot.fit.Pow
 
value(double[]) - Method in class jhplot.fit.PowModified
 
value(double, double) - Method in class org.apache.commons.math.analysis.BinaryFunction
Deprecated. Compute the value for the function.
value(double, double) - Method in interface org.apache.commons.math.analysis.BivariateRealFunction
Compute the value for the function.
value(double) - Method in class org.apache.commons.math.analysis.ComposableFunction
Compute the value for the function.
value(double, double) - Method in class org.apache.commons.math.analysis.interpolation.BicubicSplineInterpolatingFunction
Compute the value for the function.
value(double[]) - Method in class org.apache.commons.math.analysis.interpolation.MicrosphereInterpolatingFunction
 
value(double, double, double) - Method in class org.apache.commons.math.analysis.interpolation.TricubicSplineInterpolatingFunction
Compute the value for the function.
value(double[]) - Method in interface org.apache.commons.math.analysis.MultivariateMatrixFunction
Compute the value for the function at the given point.
value(double[]) - Method in interface org.apache.commons.math.analysis.MultivariateRealFunction
Compute the value for the function at the given point.
value(double[]) - Method in interface org.apache.commons.math.analysis.MultivariateVectorialFunction
Compute the value for the function at the given point.
value(double) - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunction
Compute the value of the function for the given argument.
value(double) - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionLagrangeForm
Compute the value for the function.
value(double) - Method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionNewtonForm
Calculate the function value at the given point.
value(double) - Method in class org.apache.commons.math.analysis.polynomials.PolynomialSplineFunction
Compute the value for the function.
value(double, double, double) - Method in interface org.apache.commons.math.analysis.TrivariateRealFunction
Compute the value for the function.
value(double) - Method in interface org.apache.commons.math.analysis.UnivariateMatrixFunction
Compute the value for the function.
value(double) - Method in interface org.apache.commons.math.analysis.UnivariateRealFunction
Compute the value for the function.
value(double) - Method in interface org.apache.commons.math.analysis.UnivariateVectorialFunction
Compute the value for the function.
value(double) - Method in class org.apache.commons.math.optimization.fitting.GaussianDerivativeFunction
Compute the value for the function.
value(double) - Method in class org.apache.commons.math.optimization.fitting.GaussianFunction
Compute the value for the function.
value(double) - Method in class org.apache.commons.math.optimization.fitting.HarmonicFunction
Compute the value for the function.
value(double, double[]) - Method in class org.apache.commons.math.optimization.fitting.ParametricGaussianFunction
Computes value of function f(x) for the specified x and parameters a, b, c, and d.
value(double, double[]) - Method in interface org.apache.commons.math.optimization.fitting.ParametricRealFunction
Compute the value of the function.
value(double[]) - Method in class org.apache.commons.math.optimization.LeastSquaresConverter
Compute the value for the function at the given point.
value() - Method in class org.apache.commons.math.util.OpenIntToDoubleHashMap.Iterator
Get the value of current entry.
value() - Method in class org.apache.commons.math.util.OpenIntToFieldHashMap.Iterator
Get the value of current entry.
value() - Method in class umontreal.iro.lecuyer.simevents.Continuous
Returns the current value of this continuous-time variable.
valueArea(double[][], String, String) - Method in class jhplot.HChart
Set a value to Area data set.
valueBar(double, String, String) - Method in class jhplot.HChart
Set a value to a Bar chart.
valueBar3D(double, String, String) - Method in class jhplot.HChart
Set a value to a 3D Bar chart.
valueChanged(TreeSelectionEvent) - Method in class jhplot.root.RootHistogramBrowser
 
ValueErr - Class in jhplot.math
A value represented with the number (value) and associated error.
ValueErr() - Constructor for class jhplot.math.ValueErr
Initialize error propagations
ValueErr(double) - Constructor for class jhplot.math.ValueErr
Initialize with value and set error=0
ValueErr(double, double) - Constructor for class jhplot.math.ValueErr
Initialize error propagation
valueHistogram(double[]) - Method in class jhplot.HChart
Set data to make a histogram.
valueHistogram(double[], String, int, double, double) - Method in class jhplot.HChart
Build a histogram from an array.
valueLine(double, String, String) - Method in class jhplot.HChart
Set a value to a Line chart.
valueOf(String) - Static method in enum cern.colt.matrix.io.MatrixInfo.MatrixField
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum cern.colt.matrix.io.MatrixInfo.MatrixSymmetry
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum cern.colt.matrix.io.VectorInfo.VectorField
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum cern.colt.matrix.Norm
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum cern.colt.matrix.tdouble.algo.solver.DoubleNotConvergedException.Reason
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum cern.colt.matrix.tdouble.algo.solver.HyBRInnerSolver
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum cern.colt.matrix.tdouble.algo.solver.HyBRRegularizationMethod
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum cern.colt.matrix.tfloat.algo.solver.FloatNotConvergedException.Reason
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum cern.colt.matrix.Transpose
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum hephysics.vec.SpacePoint.Representation
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math.dfp.DfpField.RoundingMode
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math.exception.util.LocalizedFormats
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math.optimization.general.ConjugateGradientFormula
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math.optimization.GoalType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math.optimization.linear.Relationship
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math.stat.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math.stat.descriptive.moment.SemiVariance.Direction
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math.stat.ranking.NaNStrategy
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math.stat.ranking.TiesStrategy
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.apache.commons.math.util.MathUtils.OrderDirection
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.netlib.utils.JNIMethods.ARCHType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.netlib.utils.JNIMethods.OSType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum umontreal.iro.lecuyer.simevents.ContinuousState.IntegMethod
Returns the enum constant of this type with the specified name.
valueOf(Class<T>, String) - Static method in class umontreal.iro.lecuyer.util.Introspection
Returns the field of class cls corresponding to the name name.
valueOf(String) - Static method in enum umontreal.iro.lecuyer.util.TimeUnit
Returns the enum constant of this type with the specified name.
valueOfIgnoreCase(Class<T>, String) - Static method in class umontreal.iro.lecuyer.util.Introspection
Similar to valueOf (cls, name), with case insensitive field name look-up.
valuePie(String, double) - Method in class jhplot.HChart
Set a value to pie data set
valuePie3D(String, double) - Method in class jhplot.HChart
Set a value to 3D pie data set.
values() - Method in class cern.colt.map.AbstractDoubleIntMap
Returns a list filled with all values contained in the receiver.
values(IntArrayList) - Method in class cern.colt.map.AbstractDoubleIntMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.AbstractIntDoubleMap
Returns a list filled with all values contained in the receiver.
values(DoubleArrayList) - Method in class cern.colt.map.AbstractIntDoubleMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.AbstractIntIntMap
Returns a list filled with all values contained in the receiver.
values(IntArrayList) - Method in class cern.colt.map.AbstractIntIntMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.AbstractIntObjectMap
Returns a list filled with all values contained in the receiver.
values(ObjectArrayList) - Method in class cern.colt.map.AbstractIntObjectMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.AbstractLongObjectMap
Returns a list filled with all values contained in the receiver.
values(ObjectArrayList) - Method in class cern.colt.map.AbstractLongObjectMap
Fills all values contained in the receiver into the specified list.
values(IntArrayList) - Method in class cern.colt.map.OpenDoubleIntHashMap
Fills all values contained in the receiver into the specified list.
values(DoubleArrayList) - Method in class cern.colt.map.OpenIntDoubleHashMap
Fills all values contained in the receiver into the specified list.
values(IntArrayList) - Method in class cern.colt.map.OpenIntIntHashMap
Fills all values contained in the receiver into the specified list.
values(ObjectArrayList) - Method in class cern.colt.map.OpenIntObjectHashMap
Fills all values contained in the receiver into the specified list.
values(ObjectArrayList) - Method in class cern.colt.map.OpenLongObjectHashMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Returns a list filled with all values contained in the receiver.
values(IntArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleIntMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Returns a list filled with all values contained in the receiver.
values(LongArrayList) - Method in class cern.colt.map.tdouble.AbstractDoubleLongMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Returns a list filled with all values contained in the receiver.
values(DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractIntDoubleMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Returns a list filled with all values contained in the receiver.
values(DoubleArrayList) - Method in class cern.colt.map.tdouble.AbstractLongDoubleMap
Fills all values contained in the receiver into the specified list.
values(IntArrayList) - Method in class cern.colt.map.tdouble.OpenDoubleIntHashMap
Fills all values contained in the receiver into the specified list.
values(LongArrayList) - Method in class cern.colt.map.tdouble.OpenDoubleLongHashMap
Fills all values contained in the receiver into the specified list.
values(DoubleArrayList) - Method in class cern.colt.map.tdouble.OpenIntDoubleHashMap
Fills all values contained in the receiver into the specified list.
values(DoubleArrayList) - Method in class cern.colt.map.tdouble.OpenLongDoubleHashMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Returns a list filled with all values contained in the receiver.
values(IntArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatIntMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Returns a list filled with all values contained in the receiver.
values(LongArrayList) - Method in class cern.colt.map.tfloat.AbstractFloatLongMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Returns a list filled with all values contained in the receiver.
values(FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractIntFloatMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Returns a list filled with all values contained in the receiver.
values(FloatArrayList) - Method in class cern.colt.map.tfloat.AbstractLongFloatMap
Fills all values contained in the receiver into the specified list.
values(IntArrayList) - Method in class cern.colt.map.tfloat.OpenFloatIntHashMap
Fills all values contained in the receiver into the specified list.
values(LongArrayList) - Method in class cern.colt.map.tfloat.OpenFloatLongHashMap
Fills all values contained in the receiver into the specified list.
values(FloatArrayList) - Method in class cern.colt.map.tfloat.OpenIntFloatHashMap
Fills all values contained in the receiver into the specified list.
values(FloatArrayList) - Method in class cern.colt.map.tfloat.OpenLongFloatHashMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tint.AbstractIntIntMap
Returns a list filled with all values contained in the receiver.
values(IntArrayList) - Method in class cern.colt.map.tint.AbstractIntIntMap
Fills all values contained in the receiver into the specified list.
values(IntArrayList) - Method in class cern.colt.map.tint.OpenIntIntHashMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tlong.AbstractIntLongMap
Returns a list filled with all values contained in the receiver.
values(LongArrayList) - Method in class cern.colt.map.tlong.AbstractIntLongMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tlong.AbstractLongIntMap
Returns a list filled with all values contained in the receiver.
values(IntArrayList) - Method in class cern.colt.map.tlong.AbstractLongIntMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tlong.AbstractLongLongMap
Returns a list filled with all values contained in the receiver.
values(LongArrayList) - Method in class cern.colt.map.tlong.AbstractLongLongMap
Fills all values contained in the receiver into the specified list.
values(LongArrayList) - Method in class cern.colt.map.tlong.OpenIntLongHashMap
Fills all values contained in the receiver into the specified list.
values(IntArrayList) - Method in class cern.colt.map.tlong.OpenLongIntHashMap
Fills all values contained in the receiver into the specified list.
values(LongArrayList) - Method in class cern.colt.map.tlong.OpenLongLongHashMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Returns a list filled with all values contained in the receiver.
values(ObjectArrayList) - Method in class cern.colt.map.tobject.AbstractIntObjectMap
Fills all values contained in the receiver into the specified list.
values() - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Returns a list filled with all values contained in the receiver.
values(ObjectArrayList) - Method in class cern.colt.map.tobject.AbstractLongObjectMap
Fills all values contained in the receiver into the specified list.
values(ObjectArrayList) - Method in class cern.colt.map.tobject.OpenIntObjectHashMap
Fills all values contained in the receiver into the specified list.
values(ObjectArrayList) - Method in class cern.colt.map.tobject.OpenLongObjectHashMap
Fills all values contained in the receiver into the specified list.
values() - Static method in enum cern.colt.matrix.io.MatrixInfo.MatrixField
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum cern.colt.matrix.io.MatrixInfo.MatrixSymmetry
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum cern.colt.matrix.io.VectorInfo.VectorField
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum cern.colt.matrix.Norm
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum cern.colt.matrix.tdouble.algo.solver.DoubleNotConvergedException.Reason
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum cern.colt.matrix.tdouble.algo.solver.HyBRInnerSolver
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum cern.colt.matrix.tdouble.algo.solver.HyBRRegularizationMethod
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum cern.colt.matrix.tfloat.algo.solver.FloatNotConvergedException.Reason
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum cern.colt.matrix.Transpose
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum hephysics.vec.SpacePoint.Representation
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math.dfp.DfpField.RoundingMode
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math.exception.util.LocalizedFormats
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math.optimization.general.ConjugateGradientFormula
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math.optimization.GoalType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math.optimization.linear.Relationship
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math.stat.clustering.KMeansPlusPlusClusterer.EmptyClusterStrategy
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math.stat.descriptive.moment.SemiVariance.Direction
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math.stat.ranking.NaNStrategy
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math.stat.ranking.TiesStrategy
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.apache.commons.math.util.MathUtils.OrderDirection
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.netlib.utils.JNIMethods.ARCHType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.netlib.utils.JNIMethods.OSType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum umontreal.iro.lecuyer.simevents.ContinuousState.IntegMethod
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum umontreal.iro.lecuyer.util.TimeUnit
Returns an array containing the constants of this enum type, in the order they are declared.
ValueServer - Class in org.apache.commons.math.random
Generates values for use in simulation applications.
ValueServer() - Constructor for class org.apache.commons.math.random.ValueServer
Creates new ValueServer
ValueServer(RandomData) - Constructor for class org.apache.commons.math.random.ValueServer
Construct a ValueServer instance using a RandomData as its source of random data.
valuesIterator() - Method in class org.apache.commons.math.stat.Frequency
Returns an Iterator over the set of values that have been added.
valueX(int) - Method in class hep.aida.ref.histogram.Cloud2D
Get a given x value from the Cloud.
valueX(int) - Method in class hep.aida.ref.histogram.Cloud3D
Get a given x value from the Cloud.
valueXY(P1D) - Method in class jhplot.HChart
Set XY data from a P1D.
valueXYerrors(P1D) - Method in class jhplot.HChart
Set XY data from a P1D.
valueY(int) - Method in class hep.aida.ref.histogram.Cloud2D
Get a given y value from the Cloud.
valueY(int) - Method in class hep.aida.ref.histogram.Cloud3D
Get a given y value from the Cloud.
valueZ(int) - Method in class hep.aida.ref.histogram.Cloud3D
Get a given z value from the Cloud.
VariableAxis - Class in cern.hep.aida.ref
Variable-width axis; A reference implementation of hep.aida.IAxis.
VariableAxis(double[]) - Constructor for class cern.hep.aida.ref.VariableAxis
Constructs and returns an axis with the given bin edges.
VariableAxis - Class in hep.aida.ref.histogram
Variable-width axis; A reference implementation of hep.aida.IAxis.
VariableAxis(double[]) - Constructor for class hep.aida.ref.histogram.VariableAxis
Constructs and returns an axis with the given bin edges.
variableModel - Variable in class jhplot.io.HFileBrowser
 
variableModel - Variable in class jhplot.io.PFileBrowser
 
variableName(int) - Method in class hep.aida.ref.fitter.InternalFitFunction
 
variableName(int) - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
variableName(int) - Method in class hep.aida.ref.function.AbstractIFunction
 
variableName(int) - Method in class hep.aida.ref.function.BaseModelFunction
 
variableName(int) - Method in class hep.aida.ref.function.SumOfFunctions
 
variableNames() - Method in class hep.aida.ref.fitter.InternalFitFunction
 
variableNames() - Method in class hep.aida.ref.function.AbstractDevModelFunction
 
variableNames() - Method in class hep.aida.ref.function.AbstractIFunction
 
variableNames() - Method in class hep.aida.ref.function.BaseModelFunction
 
variableNames() - Method in class hep.aida.ref.function.SumOfFunctions
 
variance() - Method in class cern.hep.aida.bin.AbstractBin1D
Returns the sample variance, which is Sum( (x[i]-mean())2 ) / (size()-1).
variance(double) - Static method in class cern.jet.stat.Descriptive
Returns the variance from a standard deviation.
variance(int, double, double) - Static method in class cern.jet.stat.Descriptive
Returns the variance of a data sequence.
variance(double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the variance from a standard deviation.
variance(int, double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the variance of a data sequence.
variance(float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the variance from a standard deviation.
variance(int, float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the variance of a data sequence.
variance() - Method in class flanagan.analysis.Stat
 
variance(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
variance(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
variance(Complex[]) - Static method in class flanagan.analysis.Stat
 
variance(double[]) - Static method in class flanagan.analysis.Stat
 
variance(float[]) - Static method in class flanagan.analysis.Stat
 
variance(int[]) - Static method in class flanagan.analysis.Stat
 
variance(long[]) - Static method in class flanagan.analysis.Stat
 
variance(double[], double[]) - Static method in class flanagan.analysis.Stat
 
variance(float[], float[]) - Static method in class flanagan.analysis.Stat
 
variance(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
variance(BigDecimal[], BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
variance(BigInteger[], BigInteger[]) - Static method in class flanagan.analysis.Stat
 
variance() - Method in class flanagan.math.Matrix
 
variance() - Method in class hep.aida.tdouble.bin.AbstractDoubleBin1D
Returns the sample variance, which is Sum( (x[i]-mean())2 ) / (size()-1).
variance() - Method in class hep.aida.tfloat.bin.AbstractFloatBin1D
Returns the sample variance, which is Sum( (x[i]-mean())2 ) / (size()-1).
variance(double[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the (bias-corrected sample) variance.
variance(int[]) - Static method in class jhplot.math.ArrayMathUtils
Computes the (bias-corrected sample) variance.
variance(double[]) - Static method in class jhplot.math.StatisticSample
Variance
variance(double[][]) - Static method in class jhplot.math.StatisticSample
Variance
variance() - Method in class jhplot.P0D
Returns the variance.
variance() - Method in class jhplot.P0I
Returns the variance.
variance(double[]) - Static method in class jhplot.stat.Statistics
Variance
variance(double[][]) - Static method in class jhplot.stat.Statistics
Variance
Variance - Class in org.apache.commons.math.stat.descriptive.moment
Computes the variance of the available values.
Variance() - Constructor for class org.apache.commons.math.stat.descriptive.moment.Variance
Constructs a Variance with default (true) isBiasCorrected property.
Variance(SecondMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Variance
Constructs a Variance based on an external second moment.
Variance(boolean) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Variance
Constructs a Variance with the specified isBiasCorrected property
Variance(boolean, SecondMoment) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Variance
Constructs a Variance with the specified isBiasCorrected property and the supplied external second moment.
Variance(Variance) - Constructor for class org.apache.commons.math.stat.descriptive.moment.Variance
Copy constructor, creates a new Variance identical to the original
variance(double[]) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the variance of the entries in the input array, or Double.NaN if the array is empty.
variance(double[], int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the variance of the entries in the specified portion of the input array, or Double.NaN if the designated subarray is empty.
variance(double[], double, int, int) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the variance of the entries in the specified portion of the input array, using the precomputed mean value.
variance(double[], double) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the variance of the entries in the input array, using the precomputed mean value.
variance(double[]) - Method in class umontreal.iro.lecuyer.stat.list.ListOfTallies
For each tally in this list, computes the sample variance, and stores the variances into the array v.
variance() - Method in class umontreal.iro.lecuyer.stat.Tally
Returns the sample variance of the observations since the last initialization.
variance_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
variance_as_Complex() - Method in class flanagan.analysis.Stat
 
variance_as_Complex_ConjugateCalcn() - Method in class flanagan.analysis.Stat
 
variance_as_double() - Method in class flanagan.analysis.Stat
 
variance_of_ComplexImaginaryParts() - Method in class flanagan.analysis.Stat
 
variance_of_ComplexModuli() - Method in class flanagan.analysis.Stat
 
variance_of_ComplexRealParts() - Method in class flanagan.analysis.Stat
 
varianceConjugateCalcn(Complex[]) - Static method in class flanagan.analysis.Stat
 
varianceConjugateCalcn(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
varianceDifference(double[], double[], double) - Static method in class org.apache.commons.math.stat.StatUtils
Returns the variance of the (signed) differences between corresponding elements of the input arrays -- i.e., var(sample1[i] - sample2[i]).
VarianceGammaProcess - Class in umontreal.iro.lecuyer.stochprocess
This class represents a variance gamma (VG) process {S(t) = X(t;θ, σ, ν) : t >= 0}.
VarianceGammaProcess() - Constructor for class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
 
VarianceGammaProcess(double, double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Constructs a new VarianceGammaProcess with parameters θ = theta, σ = sigma, ν = nu and initial value S(t0) = s0.
VarianceGammaProcess(double, BrownianMotion, GammaProcess) - Constructor for class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcess
Constructs a new VarianceGammaProcess.
VarianceGammaProcessDiff - Class in umontreal.iro.lecuyer.stochprocess
This class represents a variance gamma (VG) process {S(t) = X(t;θ, σ, ν) : t >= 0}.
VarianceGammaProcessDiff(double, double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
Constructs a new VarianceGammaProcessDiff with parameters θ = theta, σ = sigma, ν = nu and initial value S(t0) = s0.
VarianceGammaProcessDiff(double, double, double, double, GammaProcess, GammaProcess) - Constructor for class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiff
The parameters of the GammaProcess objects for Γ+ and Γ- are set to those of and their initial values Γ+(t0) and Γ-(t0) are set to t0.
VarianceGammaProcessDiffPCA - Class in umontreal.iro.lecuyer.stochprocess
Same as VarianceGammaProcessDiff, but the two inner GammaProcess'es are of PCA type.
VarianceGammaProcessDiffPCA(double, double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiffPCA
Constructs a new VarianceGammaProcessDiffPCA with parameters θ = theta, σ = sigma, ν = nu and initial value S(t0) = s0.
VarianceGammaProcessDiffPCA(double, double, double, double, GammaProcessPCA, GammaProcessPCA) - Constructor for class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiffPCA
Constructs a new VarianceGammaProcessDiffPCA with parameters θ = theta, σ = sigma, ν = nu and initial value S(t0) = s0.
VarianceGammaProcessDiffPCABridge - Class in umontreal.iro.lecuyer.stochprocess
Same as VarianceGammaProcessDiff, but the two inner GammaProcess'es are of the type PCABridge.
VarianceGammaProcessDiffPCABridge(double, double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiffPCABridge
Constructs a new VarianceGammaProcessDiffPCABridge with parameters θ = theta, σ = sigma, ν = nu and initial value S(t0) = s0.
VarianceGammaProcessDiffPCASymmetricalBridge - Class in umontreal.iro.lecuyer.stochprocess
Same as VarianceGammaProcessDiff, but the two inner GammaProcess'es are of the PCASymmetricalBridge type.
VarianceGammaProcessDiffPCASymmetricalBridge(double, double, double, double, RandomStream) - Constructor for class umontreal.iro.lecuyer.stochprocess.VarianceGammaProcessDiffPCASymmetricalBridge
Constructs a new VarianceGammaProcessDiffPCASymmetricalBridge with parameters θ = theta, σ = sigma, ν = nu and initial value S(t0) = s0.
varianceImaginaryParts(Complex[]) - Static method in class flanagan.analysis.Stat
 
varianceImaginaryParts(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
varianceModuli(Complex[]) - Static method in class flanagan.analysis.Stat
 
varianceModuli(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
varianceRealParts(Complex[]) - Static method in class flanagan.analysis.Stat
 
varianceRealParts(Complex[], Complex[]) - Static method in class flanagan.analysis.Stat
 
varianceX() - Method in class jhplot.P1D
Returns variance for X-values.
varianceY() - Method in class jhplot.P1D
Returns variance for Y-values.
varimaxAngle(double[][], int, int) - Static method in class flanagan.analysis.PCA
 
varimaxCriterion(double[][]) - Static method in class flanagan.analysis.PCA
 
varimaxRotation(int) - Method in class flanagan.analysis.PCA
 
varimaxRotation(double[][]) - Method in class flanagan.analysis.PCA
 
varimaxRotation(double[][], double[]) - Method in class flanagan.analysis.PCA
 
vars() - Method in class hep.aida.ref.fitter.fitdata.FitDataIterator
 
VecOp - Class in hephysics.vec
Utility methods for dealing with 3 and 4 vectors.
Vector3d - Class in jhplot.v3d
Vector manipulations
Vector3d() - Constructor for class jhplot.v3d.Vector3d
 
Vector3d(Vector3d) - Constructor for class jhplot.v3d.Vector3d
 
Vector3d(float, float, float) - Constructor for class jhplot.v3d.Vector3d
 
Vector3D - Class in org.apache.commons.math.geometry
This class implements vectors in a three-dimensional space.
Vector3D(double, double, double) - Constructor for class org.apache.commons.math.geometry.Vector3D
Simple constructor.
Vector3D(double, double) - Constructor for class org.apache.commons.math.geometry.Vector3D
Simple constructor.
Vector3D(double, Vector3D) - Constructor for class org.apache.commons.math.geometry.Vector3D
Multiplicative constructor Build a vector from another one and a scale factor.
Vector3D(double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math.geometry.Vector3D
Linear constructor Build a vector from two other ones and corresponding scale factors.
Vector3D(double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math.geometry.Vector3D
Linear constructor Build a vector from three other ones and corresponding scale factors.
Vector3D(double, Vector3D, double, Vector3D, double, Vector3D, double, Vector3D) - Constructor for class org.apache.commons.math.geometry.Vector3D
Linear constructor Build a vector from four other ones and corresponding scale factors.
Vector3DFormat - Class in org.apache.commons.math.geometry
Formats a 3D vector in components list format "{x; y; z}".
Vector3DFormat() - Constructor for class org.apache.commons.math.geometry.Vector3DFormat
Create an instance with default settings.
Vector3DFormat(NumberFormat) - Constructor for class org.apache.commons.math.geometry.Vector3DFormat
Create an instance with a custom number format for components.
Vector3DFormat(String, String, String) - Constructor for class org.apache.commons.math.geometry.Vector3DFormat
Create an instance with custom prefix, suffix and separator.
Vector3DFormat(String, String, String, NumberFormat) - Constructor for class org.apache.commons.math.geometry.Vector3DFormat
Create an instance with custom prefix, suffix, separator and format for components.
VectorialConvergenceChecker - Interface in org.apache.commons.math.optimization
This interface specifies how to check if a optimization algorithm has converged.
VectorialCovariance - Class in org.apache.commons.math.stat.descriptive.moment
Returns the covariance matrix of the available vectors.
VectorialCovariance(int, boolean) - Constructor for class org.apache.commons.math.stat.descriptive.moment.VectorialCovariance
Constructs a VectorialCovariance.
VectorialMean - Class in org.apache.commons.math.stat.descriptive.moment
Returns the arithmetic mean of the available vectors.
VectorialMean(int) - Constructor for class org.apache.commons.math.stat.descriptive.moment.VectorialMean
Constructs a VectorialMean.
VectorialPointValuePair - Class in org.apache.commons.math.optimization
This class holds a point and the vectorial value of an objective function at this point.
VectorialPointValuePair(double[], double[]) - Constructor for class org.apache.commons.math.optimization.VectorialPointValuePair
Build a point/objective function value pair.
VectorialPointValuePair(double[], double[], boolean) - Constructor for class org.apache.commons.math.optimization.VectorialPointValuePair
Build a point/objective function value pair.
VectorInfo - Class in cern.colt.matrix.io
Contains information on a vector in a variant of the Matrix Market exchange format
VectorInfo(boolean, VectorInfo.VectorField) - Constructor for class cern.colt.matrix.io.VectorInfo
Creates a specific type
VectorInfo.VectorField - Enum in cern.colt.matrix.io
What kind of numbers are stored
vectorize() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns a vector obtained by stacking the columns of this matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns a vector obtained by stacking the columns of each slice of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tdcomplex.impl.SparseDComplexMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Returns a vector obtained by stacking the columns of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Returns a vector obtained by stacking the columns of each slice of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns a vector obtained by stacking the columns of this matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns a vector obtained by stacking the columns of each slice of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tfcomplex.impl.SparseFComplexMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Returns a vector obtained by stacking the columns of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Returns a vector obtained by stacking the columns of each slice of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tint.IntMatrix2D
Returns a vector obtained by stacking the columns of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tint.IntMatrix3D
Returns a vector obtained by stacking the columns of each slice of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Returns a vector obtained by stacking the columns of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Returns a vector obtained by stacking the columns of each slice of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tobject.impl.DenseColumnObjectMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tobject.impl.DenseObjectMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tobject.impl.SparseObjectMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
vectorize() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
vectorize() - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Returns a vector obtained by stacking the columns of the matrix on top of one another.
vectorize() - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Returns a vector obtained by stacking the columns of the matrix on top of one another.
vectorNorm2(DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the two-norm (aka euclidean norm) of vector X.vectorize();
vectorNorm2(DoubleMatrix3D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Returns the two-norm (aka euclidean norm) of vector X.vectorize();
vectorNorm2(FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the two-norm (aka euclidean norm) of vector X.vectorize();
vectorNorm2(FloatMatrix3D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Returns the two-norm (aka euclidean norm) of vector X.vectorize();
VectorSize - Class in cern.colt.matrix.io
Contains the size of a vector stored in a variant of the Matrix Market exchange format
VectorSize(int) - Constructor for class cern.colt.matrix.io.VectorSize
Constructor for VectorSize.
VectorSize(int, int) - Constructor for class cern.colt.matrix.io.VectorSize
Constructor for VectorSize
verifyDataSet(double[]) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Verifies that the data set has length of power of 2.
verifyDataSet(Object[]) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Verifies that the data set has length of power of 2.
verifyInterpolationArray(double[], double[]) - Static method in class org.apache.commons.math.analysis.polynomials.PolynomialFunctionLagrangeForm
Verifies that the interpolation arrays are valid.
verifyInterval(double, double) - Static method in class org.apache.commons.math.transform.FastFourierTransformer
Verifies that the endpoints specify an interval.
vers(double) - Static method in class flanagan.math.Fmath
 
Version - Class in cern.colt
Information about the current release.
VERSION - Static variable in class jhplot.HPlotJa
The current version of japlot.jaxodraw.
Version - Static variable in class jhplot.HZirkel
 
VERSION_NUMBER - Static variable in class jhplot.HPlotJa
The version number of this release of japlot.jaxodraw.
Vertex(int, float, float) - Static method in class jhplot.jadraw.Diagram
Get a vertex object
verticalSum() - Method in class jhplot.bsom.Matrix
Make a vertical-summation vector.
veteransDayUK() - Method in class flanagan.math.TimeAndDate
 
veteransDayUK(int) - Method in class flanagan.math.TimeAndDate
 
VHolder - Class in jhplot
A class to transform any HPlot container (H1D,H2D,P1D..) to a vector for further manipulations
VHolder(H1D, boolean) - Constructor for class jhplot.VHolder
Create a VHolder object with H1D histogram
VHolder(F1D, boolean) - Constructor for class jhplot.VHolder
Create a VHolder object with F1D function
VHolder(DataHolder, boolean) - Constructor for class jhplot.VHolder
Get Vectors from multidimensional data container
VHolder(P1D, boolean) - Constructor for class jhplot.VHolder
Create a VHolder object from P1D container.
VHolder(P2D, boolean) - Constructor for class jhplot.VHolder
Create a VHolder object from P2D container.
VHolder(P0D, boolean) - Constructor for class jhplot.VHolder
Create a VHolder object from P0D container.
VHolder(P0I, boolean) - Constructor for class jhplot.VHolder
Create a VHolder object from P0D container.
VHolder(P3D, boolean) - Constructor for class jhplot.VHolder
Create a VHolder object from P3D container.
view(int, int) - Method in class umontreal.iro.lecuyer.charts.BoxChart
Displays chart on the screen using Swing.
view(int, int) - Method in class umontreal.iro.lecuyer.charts.CategoryChart
 
view(int, int) - Method in class umontreal.iro.lecuyer.charts.EmpiricalChart
Displays chart on the screen using Swing.
view(int, int) - Method in class umontreal.iro.lecuyer.charts.HistogramChart
Displays chart on the screen using Swing.
view(int, int) - Method in class umontreal.iro.lecuyer.charts.MultipleDatasetChart
Displays chart on the screen using Swing.
view(int, int) - Method in class umontreal.iro.lecuyer.charts.ScatterChart
Displays chart on the screen using Swing.
view(int, int) - Method in class umontreal.iro.lecuyer.charts.XYChart
 
view(int, int) - Method in class umontreal.iro.lecuyer.charts.XYLineChart
Displays chart on the screen using Swing.
viewBar(int, int) - Method in class umontreal.iro.lecuyer.charts.XYLineChart
Displays bar chart on the screen using Swing.
viewCdf(int, int) - Method in class umontreal.iro.lecuyer.charts.ContinuousDistChart
Displays a chart of the cumulative distribution function (cdf) on the screen using Swing.
viewCdf(int, int, int, int) - Method in class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Displays a chart of the cumulative distribution function (cdf) over the interval [a, b] on the screen using Swing.
viewCdf(int, int) - Method in class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Similar to method viewCdf above.
viewColumn(int) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCMDComplexMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
viewColumn(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tdouble.impl.SparseCCMDoubleMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
viewColumn(int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCMFComplexMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
viewColumn(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tfloat.impl.SparseCCMFloatMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
viewColumn(int) - Method in class cern.colt.matrix.tint.impl.SparseCCMIntMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
viewColumn(int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tlong.impl.SparseCCMLongMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
viewColumn(int) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tobject.impl.SparseCCMObjectMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
viewColumn(int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
viewColumn(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a new slice view representing the rows of the given column.
viewColumn(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and rows of the given column.
viewColumnFlip() - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
viewColumnFlip() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
viewColumnFlip() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
viewColumnFlip() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
viewColumnFlip() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
viewColumnFlip() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
viewColumnFlip() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
viewColumnFlip() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
viewColumnFlip() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
viewColumnFlip() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
viewColumnFlip() - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a new flip view aint the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new flip view aint the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
viewColumnFlip() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
viewColumnFlip() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
viewColumnFlip() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
viewColumnFlip() - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a new flip view along the column axis.
viewColumnFlip() - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new flip view along the column axis.
viewDensity(int, int) - Method in class umontreal.iro.lecuyer.charts.ContinuousDistChart
Similar to viewCdf, but for the probability density instead of the cdf.
viewDice() - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewDice() - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewDice() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewDice() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
viewDice(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
viewDice() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewDice() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
viewDice(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
viewDice() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewDice() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
viewDice(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
viewDice() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewDice() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
viewDice(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
viewDice() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
viewDice(int, int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
viewDice() - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewDice() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
viewDice(int, int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
viewDice() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewDice() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
viewDice(int, int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
viewDice() - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a new dice (transposition) view; Swaps axes; example: 3 x 4 matrix --> 4 x 3 matrix.
viewDice(int, int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new dice view; Swaps dimensions (axes); Example: 3 x 4 x 5 matrix --> 4 x 3 x 5 matrix.
viewFlip() - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
viewFlip() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
viewFlip() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
viewFlip() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
viewFlip() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.tint.IntMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
Constructs and returns a new flip view.
viewFlip() - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Constructs and returns a new flip view.
viewHisto(boolean) - Method in class jhplot.HPlot
If true, then this suppresses all negative values in Y, i.e.
viewPart(int, int) - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewPart(int, int) - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewPart(int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewPart(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
viewPart(int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewPart(int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
viewPart(int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewPart(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
viewPart(int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewPart(int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
viewPart(int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
viewPart(int, int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewPart(int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
viewPart(int, int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewPart(int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
viewPart(int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Constructs and returns a new sub-range view that is a width sub matrix starting at index.
viewPart(int, int, int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a new sub-range view that is a height x width sub matrix starting at [row,column].
viewPart(int, int, int, int, int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new sub-range view that is a depth x height x width sub matrix starting at [slice,row,column]; Equivalent to view().part(slice,row,column,depth,height,width); Provided for convenience only.
viewProb(int, int, int, int) - Method in class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Displays a chart of the probability mass function over the interval [a, b] on the screen using Swing.
viewProb(int, int) - Method in class umontreal.iro.lecuyer.charts.DiscreteDistIntChart
Similar to method viewProb above.
viewRow(int) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCMDComplexMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
viewRow(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tdouble.impl.SparseRCMDoubleMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
viewRow(int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCMFComplexMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
viewRow(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tfloat.impl.SparseRCMFloatMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
viewRow(int) - Method in class cern.colt.matrix.tint.impl.SparseRCMIntMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
viewRow(int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tlong.impl.SparseRCMLongMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
viewRow(int) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tobject.impl.SparseRCMObjectMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
viewRow(int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
viewRow(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a new slice view representing the columns of the given row.
viewRow(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new 2-dimensional slice view representing the slices and columns of the given row.
viewRowFlip() - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
viewRowFlip() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
viewRowFlip() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
viewRowFlip() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
viewRowFlip() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
viewRowFlip() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
viewRowFlip() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
viewRowFlip() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
viewRowFlip() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
viewRowFlip() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
viewRowFlip() - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a new flip view aint the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new flip view aint the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
viewRowFlip() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
viewRowFlip() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
viewRowFlip() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
viewRowFlip() - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a new flip view along the row axis.
viewRowFlip() - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new flip view along the row axis.
viewSample(DoubleMatrix1D, double, RandomEngine) - Static method in class cern.colt.matrix.doublealgo.Statistic
Constructs and returns a sampling view with a size of round(matrix.size() * fraction).
viewSample(DoubleMatrix2D, double, double, RandomEngine) - Static method in class cern.colt.matrix.doublealgo.Statistic
Constructs and returns a sampling view with round(matrix.rows() * rowFraction) rows and round(matrix.columns() * columnFraction) columns.
viewSample(DoubleMatrix3D, double, double, double, RandomEngine) - Static method in class cern.colt.matrix.doublealgo.Statistic
Constructs and returns a sampling view with round(matrix.slices() * sliceFraction) slices and round(matrix.rows() * rowFraction) rows and round(matrix.columns() * columnFraction) columns.
viewSample(DoubleMatrix1D, double, DoubleRandomEngine) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Constructs and returns a sampling view with a size of round(matrix.size() * fraction).
viewSample(DoubleMatrix2D, double, double, DoubleRandomEngine) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Constructs and returns a sampling view with round(matrix.rows() * rowFraction) rows and round(matrix.columns() * columnFraction) columns.
viewSample(DoubleMatrix3D, double, double, double, DoubleRandomEngine) - Static method in class cern.colt.matrix.tdouble.algo.DoubleStatistic
Constructs and returns a sampling view with round(matrix.slices() * sliceFraction) slices and round(matrix.rows() * rowFraction) rows and round(matrix.columns() * columnFraction) columns.
viewSample(FloatMatrix1D, float, FloatRandomEngine) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Constructs and returns a sampling view with a size of round(matrix.size() * fraction).
viewSample(FloatMatrix2D, float, float, FloatRandomEngine) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Constructs and returns a sampling view with round(matrix.rows() * rowFraction) rows and round(matrix.columns() * columnFraction) columns.
viewSample(FloatMatrix3D, float, float, float, FloatRandomEngine) - Static method in class cern.colt.matrix.tfloat.algo.FloatStatistic
Constructs and returns a sampling view with round(matrix.slices() * sliceFraction) slices and round(matrix.rows() * rowFraction) rows and round(matrix.columns() * columnFraction) columns.
viewSelection(int[]) - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(DoubleProcedure) - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(DoubleMatrix1DProcedure) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(DoubleMatrix2DProcedure) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSelection(int[]) - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(ObjectProcedure) - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(ObjectMatrix1DProcedure) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(ObjectMatrix2DProcedure) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSelection(DComplexProcedure) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(DComplexMatrix1DProcedure) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(DComplexMatrix2DProcedure) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(int[]) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
viewSelection(DoubleProcedure) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[]) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(DoubleMatrix1DProcedure) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(Set<int[]>) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
 
viewSelection(DoubleMatrix2DProcedure) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(int[]) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
viewSelection(FComplexProcedure) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(FComplexMatrix1DProcedure) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(FComplexMatrix2DProcedure) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(int[]) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
viewSelection(FloatProcedure) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[]) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(FloatMatrix1DProcedure) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(Set<int[]>) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
 
viewSelection(FloatMatrix2DProcedure) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(int[]) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
viewSelection(int[]) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
viewSelection(IntProcedure) - Method in class cern.colt.matrix.tint.IntMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[]) - Method in class cern.colt.matrix.tint.IntMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(IntMatrix1DProcedure) - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(Set<int[]>) - Method in class cern.colt.matrix.tint.IntMatrix2D
 
viewSelection(IntMatrix2DProcedure) - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(int[]) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
viewSelection(LongProcedure) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[]) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(LongMatrix1DProcedure) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(Set<int[]>) - Method in class cern.colt.matrix.tlong.LongMatrix2D
 
viewSelection(LongMatrix2DProcedure) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(int[]) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
viewSelection(int[]) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(ObjectProcedure) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Constructs and returns a new selection view that is a matrix holding the cells matching the given condition.
viewSelection(int[], int[]) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(ObjectMatrix1DProcedure) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a new selection view that is a matrix holding all rows matching the given condition.
viewSelection(int[], int[], int[]) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new selection view that is a matrix holding the indicated cells.
viewSelection(ObjectMatrix2DProcedure) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new selection view that is a matrix holding all slices matching the given condition.
viewSlice(int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSlice(int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSlice(int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSlice(int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
viewSlice(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSlice(int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
viewSlice(int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSlice(int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
viewSlice(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSlice(int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
viewSlice(int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
viewSlice(int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSlice(int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
viewSlice(int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSlice(int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
viewSlice(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new 2-dimensional slice view representing the rows and columns of the given slice.
viewSliceFlip() - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new flip view along the slice axis.
viewSliceFlip() - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new flip view along the slice axis.
viewSliceFlip() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new flip view along the slice axis.
viewSliceFlip() - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
viewSliceFlip() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new flip view along the slice axis.
viewSliceFlip() - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
viewSliceFlip() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new flip view along the slice axis.
viewSliceFlip() - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
viewSliceFlip() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new flip view along the slice axis.
viewSliceFlip() - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
viewSliceFlip() - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
viewSliceFlip() - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new flip view aint the slice axis.
viewSliceFlip() - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
viewSliceFlip() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new flip view along the slice axis.
viewSliceFlip() - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
viewSliceFlip() - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new flip view along the slice axis.
viewSorted() - Method in class cern.colt.matrix.DoubleMatrix1D
Sorts the vector into ascending order, according to the natural ordering.
viewSorted(int) - Method in class cern.colt.matrix.DoubleMatrix2D
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
viewSorted(int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
viewSorted() - Method in class cern.colt.matrix.ObjectMatrix1D
Sorts the vector into ascending order, according to the natural ordering.
viewSorted(int) - Method in class cern.colt.matrix.ObjectMatrix2D
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
viewSorted(int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
viewSorted() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Sorts the vector into ascending order, according to the natural ordering.
viewSorted(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
viewSorted(int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
viewSorted() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Sorts the vector into ascending order, according to the natural ordering.
viewSorted(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
viewSorted(int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
viewSorted() - Method in class cern.colt.matrix.tint.IntMatrix1D
Sorts the vector into ascending order, according to the natural ordering.
viewSorted(int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
viewSorted(int, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
viewSorted() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Sorts the vector into ascending order, according to the natural ordering.
viewSorted(int) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
viewSorted(int, int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
viewSorted() - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Sorts the vector into ascending order, according to the natural ordering.
viewSorted(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Sorts the matrix rows into ascending order, according to the natural ordering of the matrix values in the given column.
viewSorted(int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Sorts the matrix slices into ascending order, according to the natural ordering of the matrix values in the given [row,column] position.
viewStrides(int) - Method in class cern.colt.matrix.DoubleMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.DoubleMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.DoubleMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int) - Method in class cern.colt.matrix.ObjectMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.ObjectMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.ObjectMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
viewStrides(int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
viewStrides(int, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
viewStrides(int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
viewStrides(int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
viewStrides(int, int, int) - Method in class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
viewStrides(int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
viewStrides(int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
viewStrides(int, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
viewStrides(int) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
viewStrides(int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
viewStrides(int, int, int) - Method in class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
viewStrides(int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
viewStrides(int, int, int) - Method in class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
viewStrides(int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.tint.IntMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.tint.IntMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
viewStrides(int, int, int) - Method in class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
viewStrides(int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.tlong.LongMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
viewStrides(int, int, int) - Method in class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
viewStrides(int) - Method in class cern.colt.matrix.tobject.ObjectMatrix1D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix2D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
viewStrides(int, int, int) - Method in class cern.colt.matrix.tobject.ObjectMatrix3D
Constructs and returns a new stride view which is a sub matrix consisting of every i-th cell.
visible(boolean) - Method in class jhplot.HBsom
Set frame visible or not
visible() - Method in class jhplot.HBsom
Set visible frame
visible() - Method in class jhplot.HCellular
Set visible frame
visible(boolean) - Method in class jhplot.HChart
Set the canvas frame visible or not
visible() - Method in class jhplot.HChart
Set the canvas frame visible
visible(boolean) - Method in class jhplot.HGraph
Set the canvas frame visible or not
visible() - Method in class jhplot.HGraph
Set the canvas frame visible
visible(boolean) - Method in class jhplot.HPlot
Set the canvas frame visible or not
visible() - Method in class jhplot.HPlot
Set the canvas frame visible
visible(boolean) - Method in class jhplot.HPlot2D
Set the canvas frame visible or not
visible() - Method in class jhplot.HPlot2D
Set the canvas frame visible
visible(boolean) - Method in class jhplot.HPlot3D
Set the canvas frame visible or not
visible() - Method in class jhplot.HPlot3D
Show the canvas
visible(boolean) - Method in class jhplot.HPlot3DP
Set the canvas frame visible or not
visible() - Method in class jhplot.HPlot3DP
Set the canvas frame visible
visible(boolean) - Method in class jhplot.HPlotJa
Set the canvas frame visible or not
visible() - Method in class jhplot.HPlotJa
Set the canvas frame visible
visible(boolean) - Method in class jhplot.HView3D
Set the canvas frame visible or not
visible() - Method in class jhplot.HView3D
Set the canvas frame visible
visible(boolean) - Method in class jhplot.SPlot
Show or not the frame
visible() - Method in class jhplot.SPlot
Show the frame.
visit(int, int, T) - Method in class org.apache.commons.math.linear.DefaultFieldMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, T) - Method in class org.apache.commons.math.linear.DefaultFieldMatrixPreservingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in class org.apache.commons.math.linear.DefaultRealMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in class org.apache.commons.math.linear.DefaultRealMatrixPreservingVisitor
Visit one matrix entry.
visit(int, int, T) - Method in interface org.apache.commons.math.linear.FieldMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, T) - Method in interface org.apache.commons.math.linear.FieldMatrixPreservingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in interface org.apache.commons.math.linear.RealMatrixChangingVisitor
Visit one matrix entry.
visit(int, int, double) - Method in interface org.apache.commons.math.linear.RealMatrixPreservingVisitor
Visit one matrix entry.
volatilityLogChange() - Method in class flanagan.analysis.Stat
 
volatilityLogChange(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
volatilityLogChange(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
volatilityLogChange(double[]) - Static method in class flanagan.analysis.Stat
 
volatilityLogChange(float[]) - Static method in class flanagan.analysis.Stat
 
volatilityPerCentChange() - Method in class flanagan.analysis.Stat
 
volatilityPerCentChange(BigDecimal[]) - Static method in class flanagan.analysis.Stat
 
volatilityPerCentChange(BigInteger[]) - Static method in class flanagan.analysis.Stat
 
volatilityPerCentChange(double[]) - Static method in class flanagan.analysis.Stat
 
volatilityPerCentChange(float[]) - Static method in class flanagan.analysis.Stat
 
volt - Static variable in class cern.clhep.Units
 
volume() - Method in class hep.aida.ref.function.Grid
 
volumeSphere(double, int) - Static method in class umontreal.iro.lecuyer.util.Num
Returns the volume V of a sphere of radius 1 in t dimensions using the norm Lp.
VonMises - Class in cern.jet.random.tdouble
Von Mises distribution.
VonMises(double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.VonMises
Constructs a Von Mises distribution.
VonMises - Class in cern.jet.random
Von Mises distribution.
VonMises(double, RandomEngine) - Constructor for class cern.jet.random.VonMises
Constructs a Von Mises distribution.

W

waitFor(int) - Method in class flanagan.math.TimeAndDate
 
waitFor(long) - Method in class flanagan.math.TimeAndDate
 
waitFor(double) - Method in class flanagan.math.TimeAndDate
 
waitFor() - Method in class umontreal.iro.lecuyer.simprocs.Condition
The executing process invoking this method must wait for this condition to be true.
WAITING - Static variable in class umontreal.iro.lecuyer.simprocs.SimProcess
 
waitList() - Method in class umontreal.iro.lecuyer.simprocs.Bin
Returns the list of UserRecord for the processes waiting for tokens from this bin.
waitList() - Method in class umontreal.iro.lecuyer.simprocs.Condition
Returns the list of UserRecord for the processes waiting for this condition.
waitList() - Method in class umontreal.iro.lecuyer.simprocs.Resource
Returns the list that contains the UserRecord objects for the processes in the waiting list for this resource.
walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (but don't change) some matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Visit (and possibly change) all matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Visit (but don't change) all matrix entries in column order.
walkInColumnOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Visit (and possibly change) some matrix entries in column order.
walkInColumnOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Visit (but don't change) some matrix entries in column order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (and possibly change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (but don't change) all matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (and possibly change) some matrix entries using the fastest possible order.
walkInOptimizedOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (but don't change) some matrix entries using the fastest possible order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractFieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.AbstractRealMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.Array2DRowFieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.Array2DRowRealMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in class org.apache.commons.math.linear.BlockFieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.BlockRealMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(FieldMatrixChangingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(FieldMatrixPreservingVisitor<T>, int, int, int, int) - Method in interface org.apache.commons.math.linear.FieldMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in interface org.apache.commons.math.linear.RealMatrix
Visit (but don't change) some matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Visit (and possibly change) all matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Visit (but don't change) all matrix entries in row order.
walkInRowOrder(RealMatrixChangingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Visit (and possibly change) some matrix entries in row order.
walkInRowOrder(RealMatrixPreservingVisitor, int, int, int, int) - Method in class org.apache.commons.math.linear.RealMatrixImpl
Deprecated. Visit (but don't change) some matrix entries in row order.
watsonG(DoubleArrayList) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Computes and returns the Watson statistic GN.
WatsonGDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Watson G distribution (see).
WatsonGDist(int) - Constructor for class umontreal.iro.lecuyer.probdist.WatsonGDist
Constructs a Watson distribution for a sample of size n.
watsonU(DoubleArrayList) - Static method in class umontreal.iro.lecuyer.gof.GofStat
Computes and returns the Watson statistic UN2.
WatsonUDist - Class in umontreal.iro.lecuyer.probdist
Extends the class ContinuousDistribution for the Watson U distribution (see).
WatsonUDist(int) - Constructor for class umontreal.iro.lecuyer.probdist.WatsonUDist
Constructs a Watson U distribution for a sample of size n.
watt - Static variable in class cern.clhep.Units
 
WEB_SITE - Static variable in class jhplot.HPlotJa
The japlot.jaxodraw web site.
weber - Static variable in class cern.clhep.Units
 
weibull() - Method in class flanagan.analysis.Regression
 
weibull(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
Weibull - Class in jhplot.math.num.pdf
The Weibull distribution.
Weibull() - Constructor for class jhplot.math.num.pdf.Weibull
Default constructor.
Weibull(double, double) - Constructor for class jhplot.math.num.pdf.Weibull
Create a distribution with the given parameters.
Weibull(double, double, double) - Constructor for class jhplot.math.num.pdf.Weibull
Create a distribution with the given parameters.
weibull(double, double) - Static method in class jhplot.math.Random
Generate a random number from a Weibull random variable.
weibullArray(double, double, double, int) - Method in class flanagan.math.PsRandom
 
weibullCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
weibullCDF(double, double, double, double, double) - Static method in class flanagan.analysis.Stat
 
weibullCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
WeibullDist - Class in umontreal.iro.lecuyer.probdist
This class extends the class ContinuousDistribution for the Weibull distribution with shape parameter α > 0, location parameter δ, and scale parameter λ > 0.
WeibullDist(double) - Constructor for class umontreal.iro.lecuyer.probdist.WeibullDist
Constructs a WeibullDist object with parameters α = alpha, λ = 1, and δ = 0.
WeibullDist(double, double, double) - Constructor for class umontreal.iro.lecuyer.probdist.WeibullDist
Constructs a WeibullDist object with parameters α = alpha, λ = lambda, and δ = delta.
WeibullDistribution - Interface in org.apache.commons.math.distribution
Weibull Distribution.
WeibullDistributionImpl - Class in org.apache.commons.math.distribution
Default implementation of WeibullDistribution.
WeibullDistributionImpl(double, double) - Constructor for class org.apache.commons.math.distribution.WeibullDistributionImpl
Creates weibull distribution with the given shape and scale and a location equal to zero.
WeibullDistributionImpl(double, double, double) - Constructor for class org.apache.commons.math.distribution.WeibullDistributionImpl
Creates weibull distribution with the given shape, scale and inverse cumulative probability accuracy and a location equal to zero.
weibullGamma() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullGammaError() - Method in class flanagan.analysis.ProbabilityPlot
 
WeibullGen - Class in umontreal.iro.lecuyer.randvar
This class implements random variate generators for the Weibull distribution.
WeibullGen(RandomStream, double, double, double) - Constructor for class umontreal.iro.lecuyer.randvar.WeibullGen
Creates a Weibull random variate generator with parameters α = alpha, λ = lambda and δ = delta, using stream s.
WeibullGen(RandomStream, double) - Constructor for class umontreal.iro.lecuyer.randvar.WeibullGen
Creates a Weibull random variate generator with parameters α = alpha, λ = 1 and δ = 0, using stream s.
WeibullGen(RandomStream, WeibullDist) - Constructor for class umontreal.iro.lecuyer.randvar.WeibullGen
Creates a new generator for the Weibull distribution dist and stream s.
weibullGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullInverseCDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
weibullInverseCDF(double, double, double) - Static method in class flanagan.analysis.Stat
 
weibullInverseCDF(double, double) - Static method in class flanagan.analysis.Stat
 
weibullMean(double, double, double) - Static method in class flanagan.analysis.Stat
 
weibullMedian(double, double, double) - Static method in class flanagan.analysis.Stat
 
weibullMode(double, double, double) - Static method in class flanagan.analysis.Stat
 
weibullMu() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullMuError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullOneParProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullOrderStatisticMedians(double, double, double, int) - Static method in class flanagan.analysis.Stat
 
weibullOrderStatisticMedians(double, double, int) - Static method in class flanagan.analysis.Stat
 
weibullOrderStatisticMedians(double, int) - Static method in class flanagan.analysis.Stat
 
weibullPDF(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
weibullPlot() - Method in class flanagan.analysis.Regression
 
weibullProb(double, double, double, double) - Static method in class flanagan.analysis.Stat
 
weibullProb(double, double, double, double, double) - Static method in class flanagan.analysis.Stat
 
weibullProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullRand(double, double, double, int) - Static method in class flanagan.analysis.Stat
 
weibullRand(double, double, double, int, long) - Static method in class flanagan.analysis.Stat
 
WeibullRandomVariable - Class in jhplot.math.num.random
A random variable generator for the Weibull distribution.
WeibullRandomVariable() - Constructor for class jhplot.math.num.random.WeibullRandomVariable
Default constructor.
WeibullRandomVariable(double, double) - Constructor for class jhplot.math.num.random.WeibullRandomVariable
Create a rnadom variable with the given shape and scale values.
WeibullRandomVariable(double, double, double) - Constructor for class jhplot.math.num.random.WeibullRandomVariable
Create a random variable with the given parameters.
WeibullRandomVariable(double, double, double, RNG) - Constructor for class jhplot.math.num.random.WeibullRandomVariable
Create a random variable with the given parameters.
WeibullRandomVariable(double, double, RNG) - Constructor for class jhplot.math.num.random.WeibullRandomVariable
Create a random variable with the given shape and scale values.
weibullSigma() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullSigmaError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandard() - Method in class flanagan.analysis.Regression
 
weibullStandardCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandardDeviation(double, double) - Static method in class flanagan.analysis.Stat
 
weibullStandardGamma() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandardGammaError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandardGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandardGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandardIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandardInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandardOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandardPlot() - Method in class flanagan.analysis.Regression
 
weibullStandardProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandardSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullStandDev(double, double) - Static method in class flanagan.analysis.Stat
 
weibullSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullThreeParProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoPar() - Method in class flanagan.analysis.Regression
 
weibullTwoParCorrelationCoefficient() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParGamma() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParGammaError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParGradient() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParGradientError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParIntercept() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParInterceptError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParOrderStatisticMedians() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParPlot() - Method in class flanagan.analysis.Regression
 
weibullTwoParProbabilityPlot() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParSigma() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParSigmaError() - Method in class flanagan.analysis.ProbabilityPlot
 
weibullTwoParSumOfSquares() - Method in class flanagan.analysis.ProbabilityPlot
 
weight - Variable in class cern.jet.stat.Buffer
 
weight() - Method in class cern.jet.stat.Buffer
Returns whether the receiver's weight.
weight(int) - Method in class cern.jet.stat.Buffer
Sets the receiver's weight.
weight(int) - Method in class hep.aida.ref.histogram.Cloud1D
Get a given weight from the Cloud.
weight(int) - Method in class hep.aida.ref.histogram.Cloud2D
Get a given weight from the Cloud.
weight(int) - Method in class hep.aida.ref.histogram.Cloud3D
Get a given weight from the Cloud.
weightedCoefficientOfVariation() - Method in class flanagan.analysis.Stat
 
WeightedDoubleRandomSampler - Class in cern.jet.random.tdouble.sampling
Conveniently computes a stable subsequence of elements from a given input sequence; Picks (samples) exactly one random element from successive blocks of weight input elements each.
WeightedDoubleRandomSampler() - Constructor for class cern.jet.random.tdouble.sampling.WeightedDoubleRandomSampler
Calls BlockedRandomSampler(1,null).
WeightedDoubleRandomSampler(int, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.sampling.WeightedDoubleRandomSampler
Chooses exactly one random element from successive blocks of weight input elements each.
WeightedEvaluation - Interface in org.apache.commons.math.stat.descriptive
Weighted evaluation for statistics.
WeightedFloatRandomSampler - Class in cern.jet.random.tfloat.sampling
Conveniently computes a stable subsequence of elements from a given input sequence; Picks (samples) exactly one random element from successive blocks of weight input elements each.
WeightedFloatRandomSampler() - Constructor for class cern.jet.random.tfloat.sampling.WeightedFloatRandomSampler
Calls BlockedRandomSampler(1,null).
WeightedFloatRandomSampler(int, FloatRandomEngine) - Constructor for class cern.jet.random.tfloat.sampling.WeightedFloatRandomSampler
Chooses exactly one random element from successive blocks of weight input elements each.
weightedGeneralisedMean(double) - Method in class flanagan.analysis.Stat
 
weightedGeneralisedMean(BigDecimal) - Method in class flanagan.analysis.Stat
 
weightedGeneralisedMean(Complex[], Complex[], double) - Static method in class flanagan.analysis.Stat
 
weightedGeneralisedMean(Complex[], Complex[], Complex) - Static method in class flanagan.analysis.Stat
 
weightedGeneralisedMean(BigDecimal[], BigDecimal[], double) - Static method in class flanagan.analysis.Stat
 
weightedGeneralisedMean(BigDecimal[], BigDecimal[], BigDecimal) - Static method in class flanagan.analysis.Stat
 
weightedGeneralisedMean(BigInteger[], BigInteger[], double) - Static method in class flanagan.analysis.Stat
 
weightedGeneralisedMean(BigInteger[], BigInteger[], BigInteger) - Static method in class flanagan.analysis.Stat
 
weightedGeneralisedMean(double[], double[], double) - Static method in class flanagan.analysis.Stat
 
weightedGeneralisedMean(float[], float[], float) - Static method in class flanagan.analysis.Stat
 
weightedGeneralisedMean_as_Complex(double) - Method in class flanagan.analysis.Stat
 
weightedGeneralisedMean_as_Complex(Complex) - Method in class flanagan.analysis.Stat
 
weightedGeneralisedMean_as_double(double) - Method in class flanagan.analysis.Stat
 
weightedGeneralisedMean_as_double(BigDecimal) - Method in class flanagan.analysis.Stat
 
weightedGeneralizedMean(double) - Method in class flanagan.analysis.Stat
 
weightedGeneralizedMean(BigDecimal) - Method in class flanagan.analysis.Stat
 
weightedGeneralizedMean_as_Complex(double) - Method in class flanagan.analysis.Stat
 
weightedGeneralizedMean_as_Complex(Complex) - Method in class flanagan.analysis.Stat
 
weightedGeneralizedMean_as_double(double) - Method in class flanagan.analysis.Stat
 
weightedGeneralizedMean_as_double(BigDecimal) - Method in class flanagan.analysis.Stat
 
weightedGeometricMean() - Method in class flanagan.analysis.Stat
 
weightedGeometricMean_as_Complex() - Method in class flanagan.analysis.Stat
 
weightedGeometricMean_as_double() - Method in class flanagan.analysis.Stat
 
weightedHarmonicMean() - Method in class flanagan.analysis.Stat
 
weightedHarmonicMean_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
weightedHarmonicMean_as_Complex() - Method in class flanagan.analysis.Stat
 
weightedHarmonicMean_as_double() - Method in class flanagan.analysis.Stat
 
weightedMean(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.Descriptive
Returns the weighted mean of a data sequence.
weightedMean(DoubleArrayList, DoubleArrayList) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the weighted mean of a data sequence.
weightedMean(FloatArrayList, FloatArrayList) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the weighted mean of a data sequence.
weightedMean() - Method in class flanagan.analysis.Stat
 
weightedMean(String, IDataPointSet, IDataPointSet) - Method in class hep.aida.ref.histogram.DataPointSetFactory
 
weightedMean_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
weightedMean_as_Complex() - Method in class flanagan.analysis.Stat
 
weightedMean_as_double() - Method in class flanagan.analysis.Stat
 
WeightedMeasurement - Class in org.apache.commons.math.estimation
Deprecated. as of 2.0, everything in package org.apache.commons.math.estimation has been deprecated and replaced by package org.apache.commons.math.optimization.general
WeightedMeasurement(double, double) - Constructor for class org.apache.commons.math.estimation.WeightedMeasurement
Deprecated. Simple constructor.
WeightedMeasurement(double, double, boolean) - Constructor for class org.apache.commons.math.estimation.WeightedMeasurement
Deprecated. Simple constructor.
WeightedObservedPoint - Class in org.apache.commons.math.optimization.fitting
This class is a simple container for weighted observed point in curve fitting.
WeightedObservedPoint(double, double, double) - Constructor for class org.apache.commons.math.optimization.fitting.WeightedObservedPoint
Simple constructor.
WeightedRandomSampler - Class in cern.jet.random.sampling
Conveniently computes a stable subsequence of elements from a given input sequence; Picks (samples) exactly one random element from successive blocks of weight input elements each.
WeightedRandomSampler() - Constructor for class cern.jet.random.sampling.WeightedRandomSampler
Calls BlockedRandomSampler(1,null).
WeightedRandomSampler(int, RandomEngine) - Constructor for class cern.jet.random.sampling.WeightedRandomSampler
Chooses exactly one random element from successive blocks of weight input elements each.
weightedRegression() - Method in class flanagan.analysis.ProbabilityPlot
 
weightedRMS(double, double) - Static method in class cern.jet.stat.Descriptive
Returns the weighted RMS (Root-Mean-Square) of a data sequence.
weightedRMS(double, double) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the weighted RMS (Root-Mean-Square) of a data sequence.
weightedRMS(float, float) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the weighted RMS (Root-Mean-Square) of a data sequence.
weightedRms() - Method in class flanagan.analysis.Stat
 
weightedStandardDeviation() - Method in class flanagan.analysis.Stat
 
weightedStandardDeviation_as_Complex() - Method in class flanagan.analysis.Stat
 
weightedStandardDeviation_as_Complex_ConjugateCalcn() - Method in class flanagan.analysis.Stat
 
weightedStandardDeviation_as_double() - Method in class flanagan.analysis.Stat
 
weightedStandardDeviation_of_ComplexImaginaryParts() - Method in class flanagan.analysis.Stat
 
weightedStandardDeviation_of_ComplexModuli() - Method in class flanagan.analysis.Stat
 
weightedStandardDeviation_of_ComplexRealParts() - Method in class flanagan.analysis.Stat
 
weightedStandardError() - Method in class flanagan.analysis.Stat
 
weightedStandardError_as_double() - Method in class flanagan.analysis.Stat
 
weightedStandardError_of_ComplexImaginaryParts() - Method in class flanagan.analysis.Stat
 
weightedStandardError_of_ComplexModuli() - Method in class flanagan.analysis.Stat
 
weightedStandardError_of_ComplexRealParts() - Method in class flanagan.analysis.Stat
 
weightedStandarError_as_Complex() - Method in class flanagan.analysis.Stat
 
weightedStandarError_as_Complex_ConjugateCalcn() - Method in class flanagan.analysis.Stat
 
weightedVariance() - Method in class flanagan.analysis.Stat
 
weightedVariance_as_BigDecimal() - Method in class flanagan.analysis.Stat
 
weightedVariance_as_Complex() - Method in class flanagan.analysis.Stat
 
weightedVariance_as_Complex_ConjugateCalcn() - Method in class flanagan.analysis.Stat
 
weightedVariance_as_double() - Method in class flanagan.analysis.Stat
 
weightedVariance_of_ComplexImaginaryParts() - Method in class flanagan.analysis.Stat
 
weightedVariance_of_ComplexModuli() - Method in class flanagan.analysis.Stat
 
weightedVariance_of_ComplexRealParts() - Method in class flanagan.analysis.Stat
 
WELL1024 - Class in umontreal.iro.lecuyer.rng
Implements the RandomStream interface via inheritance from RandomStreamBase.
WELL1024() - Constructor for class umontreal.iro.lecuyer.rng.WELL1024
Constructs a new stream.
WELL1024(String) - Constructor for class umontreal.iro.lecuyer.rng.WELL1024
Constructs a new stream with the identifier name (used in the toString method).
Well1024a - Class in org.apache.commons.math.random
This class implements the WELL1024a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well1024a() - Constructor for class org.apache.commons.math.random.Well1024a
Creates a new random number generator.
Well1024a(int) - Constructor for class org.apache.commons.math.random.Well1024a
Creates a new random number generator using a single int seed.
Well1024a(int[]) - Constructor for class org.apache.commons.math.random.Well1024a
Creates a new random number generator using an int array seed.
Well1024a(long) - Constructor for class org.apache.commons.math.random.Well1024a
Creates a new random number generator using a single long seed.
Well19937a - Class in org.apache.commons.math.random
This class implements the WELL19937a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well19937a() - Constructor for class org.apache.commons.math.random.Well19937a
Creates a new random number generator.
Well19937a(int) - Constructor for class org.apache.commons.math.random.Well19937a
Creates a new random number generator using a single int seed.
Well19937a(int[]) - Constructor for class org.apache.commons.math.random.Well19937a
Creates a new random number generator using an int array seed.
Well19937a(long) - Constructor for class org.apache.commons.math.random.Well19937a
Creates a new random number generator using a single long seed.
Well19937c - Class in org.apache.commons.math.random
This class implements the WELL19937c pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well19937c() - Constructor for class org.apache.commons.math.random.Well19937c
Creates a new random number generator.
Well19937c(int) - Constructor for class org.apache.commons.math.random.Well19937c
Creates a new random number generator using a single int seed.
Well19937c(int[]) - Constructor for class org.apache.commons.math.random.Well19937c
Creates a new random number generator using an int array seed.
Well19937c(long) - Constructor for class org.apache.commons.math.random.Well19937c
Creates a new random number generator using a single long seed.
Well44497a - Class in org.apache.commons.math.random
This class implements the WELL44497a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well44497a() - Constructor for class org.apache.commons.math.random.Well44497a
Creates a new random number generator.
Well44497a(int) - Constructor for class org.apache.commons.math.random.Well44497a
Creates a new random number generator using a single int seed.
Well44497a(int[]) - Constructor for class org.apache.commons.math.random.Well44497a
Creates a new random number generator using an int array seed.
Well44497a(long) - Constructor for class org.apache.commons.math.random.Well44497a
Creates a new random number generator using a single long seed.
Well44497b - Class in org.apache.commons.math.random
This class implements the WELL44497b pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well44497b() - Constructor for class org.apache.commons.math.random.Well44497b
Creates a new random number generator.
Well44497b(int) - Constructor for class org.apache.commons.math.random.Well44497b
Creates a new random number generator using a single int seed.
Well44497b(int[]) - Constructor for class org.apache.commons.math.random.Well44497b
Creates a new random number generator using an int array seed.
Well44497b(long) - Constructor for class org.apache.commons.math.random.Well44497b
Creates a new random number generator using a single long seed.
WELL512 - Class in umontreal.iro.lecuyer.rng
This class implements the RandomStream interface via inheritance from RandomStreamBase.
WELL512() - Constructor for class umontreal.iro.lecuyer.rng.WELL512
Constructs a new stream.
WELL512(String) - Constructor for class umontreal.iro.lecuyer.rng.WELL512
Constructs a new stream with the identifier name (used in the toString method).
Well512a - Class in org.apache.commons.math.random
This class implements the WELL512a pseudo-random number generator from François Panneton, Pierre L'Ecuyer and Makoto Matsumoto.
Well512a() - Constructor for class org.apache.commons.math.random.Well512a
Creates a new random number generator.
Well512a(int) - Constructor for class org.apache.commons.math.random.Well512a
Creates a new random number generator using a single int seed.
Well512a(int[]) - Constructor for class org.apache.commons.math.random.Well512a
Creates a new random number generator using an int array seed.
Well512a(long) - Constructor for class org.apache.commons.math.random.Well512a
Creates a new random number generator using a single long seed.
WELL607 - Class in umontreal.iro.lecuyer.rng
This class implements the RandomStream interface via inheritance from RandomStreamBase.
WELL607() - Constructor for class umontreal.iro.lecuyer.rng.WELL607
Constructs a new stream.
WELL607(String) - Constructor for class umontreal.iro.lecuyer.rng.WELL607
Constructs a new stream with the identifier name (used in the toString method).
WG - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Watson G test
whitSunday() - Method in class flanagan.math.TimeAndDate
 
whitSunday(int) - Method in class flanagan.math.TimeAndDate
 
winsorizedMean(DoubleArrayList, double, int, int) - Static method in class cern.jet.stat.Descriptive
Returns the winsorized mean of a sorted data sequence.
winsorizedMean(DoubleArrayList, double, int, int) - Static method in class cern.jet.stat.tdouble.DoubleDescriptive
Returns the winsorized mean of a sorted data sequence.
winsorizedMean(FloatArrayList, float, int, int) - Static method in class cern.jet.stat.tfloat.FloatDescriptive
Returns the winsorized mean of a sorted data sequence.
WrapperDComplexMatrix1D - Class in cern.colt.matrix.tdcomplex.impl
1-d matrix holding complex elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperDComplexMatrix1D(DComplexMatrix1D) - Constructor for class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix1D
 
WrapperDComplexMatrix2D - Class in cern.colt.matrix.tdcomplex.impl
2-d matrix holding complex elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperDComplexMatrix2D(DComplexMatrix2D) - Constructor for class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix2D
 
WrapperDComplexMatrix3D - Class in cern.colt.matrix.tdcomplex.impl
3-d matrix holding complex elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperDComplexMatrix3D(DComplexMatrix3D) - Constructor for class cern.colt.matrix.tdcomplex.impl.WrapperDComplexMatrix3D
 
WrapperDoubleMatrix1D - Class in cern.colt.matrix.tdouble.impl
1-d matrix holding double elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperDoubleMatrix1D(DoubleMatrix1D) - Constructor for class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix1D
 
WrapperDoubleMatrix2D - Class in cern.colt.matrix.tdouble.impl
2-d matrix holding double elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperDoubleMatrix2D(DoubleMatrix2D) - Constructor for class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix2D
 
WrapperDoubleMatrix3D - Class in cern.colt.matrix.tdouble.impl
3-d matrix holding double elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperDoubleMatrix3D(DoubleMatrix3D) - Constructor for class cern.colt.matrix.tdouble.impl.WrapperDoubleMatrix3D
 
WrapperFComplexMatrix1D - Class in cern.colt.matrix.tfcomplex.impl
1-d matrix holding complex elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperFComplexMatrix1D(FComplexMatrix1D) - Constructor for class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix1D
 
WrapperFComplexMatrix2D - Class in cern.colt.matrix.tfcomplex.impl
2-d matrix holding complex elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperFComplexMatrix2D(FComplexMatrix2D) - Constructor for class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix2D
 
WrapperFComplexMatrix3D - Class in cern.colt.matrix.tfcomplex.impl
3-d matrix holding complex elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperFComplexMatrix3D(FComplexMatrix3D) - Constructor for class cern.colt.matrix.tfcomplex.impl.WrapperFComplexMatrix3D
 
WrapperFloatMatrix1D - Class in cern.colt.matrix.tfloat.impl
1-d matrix holding float elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperFloatMatrix1D(FloatMatrix1D) - Constructor for class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix1D
 
WrapperFloatMatrix2D - Class in cern.colt.matrix.tfloat.impl
2-d matrix holding float elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperFloatMatrix2D(FloatMatrix2D) - Constructor for class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix2D
 
WrapperFloatMatrix3D - Class in cern.colt.matrix.tfloat.impl
3-d matrix holding float elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperFloatMatrix3D(FloatMatrix3D) - Constructor for class cern.colt.matrix.tfloat.impl.WrapperFloatMatrix3D
 
WrapperIntMatrix1D - Class in cern.colt.matrix.tint.impl
1-d matrix holding int elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperIntMatrix1D(IntMatrix1D) - Constructor for class cern.colt.matrix.tint.impl.WrapperIntMatrix1D
 
WrapperIntMatrix2D - Class in cern.colt.matrix.tint.impl
2-d matrix holding int elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperIntMatrix2D(IntMatrix2D) - Constructor for class cern.colt.matrix.tint.impl.WrapperIntMatrix2D
 
WrapperIntMatrix3D - Class in cern.colt.matrix.tint.impl
3-d matrix holding int elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperIntMatrix3D(IntMatrix3D) - Constructor for class cern.colt.matrix.tint.impl.WrapperIntMatrix3D
 
WrapperLongMatrix1D - Class in cern.colt.matrix.tlong.impl
1-d matrix holding int elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperLongMatrix1D(LongMatrix1D) - Constructor for class cern.colt.matrix.tlong.impl.WrapperLongMatrix1D
 
WrapperLongMatrix2D - Class in cern.colt.matrix.tlong.impl
2-d matrix holding long elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperLongMatrix2D(LongMatrix2D) - Constructor for class cern.colt.matrix.tlong.impl.WrapperLongMatrix2D
 
WrapperLongMatrix3D - Class in cern.colt.matrix.tlong.impl
3-d matrix holding long elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperLongMatrix3D(LongMatrix3D) - Constructor for class cern.colt.matrix.tlong.impl.WrapperLongMatrix3D
 
WrapperObjectMatrix1D - Class in cern.colt.matrix.tobject.impl
1-d matrix holding int elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperObjectMatrix1D(ObjectMatrix1D) - Constructor for class cern.colt.matrix.tobject.impl.WrapperObjectMatrix1D
 
WrapperObjectMatrix2D - Class in cern.colt.matrix.tobject.impl
2-d matrix holding Object elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperObjectMatrix2D(ObjectMatrix2D) - Constructor for class cern.colt.matrix.tobject.impl.WrapperObjectMatrix2D
 
WrapperObjectMatrix3D - Class in cern.colt.matrix.tobject.impl
3-d matrix holding Object elements; either a view wrapping another matrix or a matrix whose views are wrappers.
WrapperObjectMatrix3D(ObjectMatrix3D) - Constructor for class cern.colt.matrix.tobject.impl.WrapperObjectMatrix3D
 
write(String) - Method in class jhplot.HBook
write an external XML file with all HBook objects (H1D, H2D, P1D)
write(String) - Method in class jhplot.HPlot
Write HPlot file and inserts graphs to the main frame.
write(ArrayList<String>) - Method in class jhplot.io.csv.CSVWriter
Writes the next line to the file.
write(PEventFile.HEvent.Builder) - Method in class jhplot.io.EFile
Add a data structure to a file
write(Object) - Method in class jhplot.io.HFile
Add an object to a file
write(Object) - Method in class jhplot.io.HFileXML
Add an object to a XML file
write(Object) - Method in class jhplot.io.PFile
Add an object to a file.
write(Object, String, boolean) - Static method in class jhplot.io.Serialized
Write an object to a serialized file.
write(Object, String) - Static method in class jhplot.io.Serialized
Write an object to a serialized file.
write(File, String) - Static method in class jhplot.math.io.ASCIIFile
 
write(String, boolean) - Method in class jhplot.math.io.ASCIIFile
Write a text in an ASCII File
write(int) - Method in class jhplot.math.io.BinaryOutputStream
Write a text in a binary File
write(int) - Method in class jhplot.math.io.LEDataOutputStream
 
write(byte[], int, int) - Method in class jhplot.math.io.LEDataOutputStream
 
write(byte[]) - Method in class jhplot.math.io.LEDataOutputStream
 
write(int) - Method in class jhplot.math.io.LERandomAccessFile
 
write(byte[], int, int) - Method in class jhplot.math.io.LERandomAccessFile
 
write(byte[]) - Method in class jhplot.math.io.LERandomAccessFile
 
write(String) - Method in class jhplot.PND
Write a PND to an external file.
write(String) - Method in class jhplot.PNI
Write a PNI to an external file.
write(String) - Method in class jhplot.SPlot
Write the current plot to a XML file
writeAll(List<String[]>) - Method in class jhplot.io.csv.CSVWriter
Writes the entire list to a CSV file.
writeAll(ResultSet, boolean) - Method in class jhplot.io.csv.CSVWriter
Writes the entire ResultSet to a CSV file.
writeAllLists(ArrayList<ArrayList<String>>) - Method in class jhplot.io.csv.CSVWriter
Writes the entire list to a CSV file.
writeBinary(String) - Method in class jhplot.P0D
Write a P0D to a binary file (big endian by default).
writeBinary(String) - Method in class jhplot.P0I
Write a P0I to a binary file (big endian by default).
writeBoolean(boolean) - Method in class jhplot.math.io.LEDataOutputStream
 
writeBoolean(boolean) - Method in class jhplot.math.io.LERandomAccessFile
 
writeByte(byte, boolean) - Method in class jhplot.math.io.BinaryFile
Write a text in a binary File
writeByte(byte, boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a text in a binary File
writeByte(int) - Method in class jhplot.math.io.LEDataOutputStream
 
writeByte(int) - Method in class jhplot.math.io.LERandomAccessFile
 
writeByteArray(byte[], boolean) - Method in class jhplot.math.io.BinaryFile
Write a text in a binary File
writeByteArray(byte[], boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a text in a binary File
writeBytes(String) - Method in class jhplot.math.io.LEDataOutputStream
 
writeBytes(String) - Method in class jhplot.math.io.LERandomAccessFile
 
writeChar(int) - Method in class jhplot.math.io.LEDataOutputStream
 
writeChar(int) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeChar.
writeChars(String) - Method in class jhplot.math.io.LEDataOutputStream
 
writeChars(String) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeChars, has to flip each char.
writeDouble(double, boolean) - Method in class jhplot.math.io.BinaryFile
Write a double in a binary File
writeDouble(double, boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a double in a binary File
writeDouble(double) - Method in class jhplot.math.io.LEDataOutputStream
 
writeDouble(double) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeDouble.
writeDoubleArray(File, double[]) - Static method in class jhplot.math.io.ASCIIFile
 
writeDoubleArray(File, double[][]) - Static method in class jhplot.math.io.ASCIIFile
 
writeDoubleArray(File, double[], String) - Static method in class jhplot.math.io.BinaryFile
 
writeDoubleArray(double[], boolean) - Method in class jhplot.math.io.BinaryFile
Write a double array in a binary File
writeDoubleArray(OutputStream, double[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
writeDoubleArray(double[], boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a double array in a binary File
writeExternal(ObjectOutput) - Method in class org.apache.commons.math.ode.sampling.AbstractStepInterpolator
writeExternal(ObjectOutput) - Method in class org.apache.commons.math.ode.sampling.DummyStepInterpolator
Write the instance to an output channel.
writeExternal(ObjectOutput) - Method in class org.apache.commons.math.ode.sampling.NordsieckStepInterpolator
writeFloat(float, boolean) - Method in class jhplot.math.io.BinaryFile
Write a float in a binary File
writeFloat(float, boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a float in a binary File
writeFloat(float) - Method in class jhplot.math.io.LEDataOutputStream
 
writeFloat(float) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeFloat.
writeFloatArray(File, float[], String) - Static method in class jhplot.math.io.BinaryFile
 
writeFloatArray(float[], boolean) - Method in class jhplot.math.io.BinaryFile
Write a float array in a binary File
writeFloatArray(OutputStream, float[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
writeFloatArray(float[], boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write a float array in a binary File
writeInt(int, boolean) - Method in class jhplot.math.io.BinaryFile
Write an int in a binary File
writeInt(int, boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write an int in a binary File
writeInt(int) - Method in class jhplot.math.io.LEDataOutputStream
 
writeInt(int) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeInt.
writeIntArray(File, int[]) - Static method in class jhplot.math.io.ASCIIFile
 
writeIntArray(File, int[][]) - Static method in class jhplot.math.io.ASCIIFile
 
writeIntArray(File, int[], String) - Static method in class jhplot.math.io.BinaryFile
 
writeIntArray(int[], boolean) - Method in class jhplot.math.io.BinaryFile
Write an int array in a binary File
writeIntArray(OutputStream, int[], String) - Static method in class jhplot.math.io.BinaryOutputStream
 
writeIntArray(int[], boolean) - Method in class jhplot.math.io.BinaryOutputStream
Write an int array in a binary File
writeLong(long) - Method in class jhplot.math.io.LEDataOutputStream
 
writeLong(long) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeLong.
writeNext(String[]) - Method in class jhplot.io.csv.CSVWriter
Writes the next line to the file.
writeObject(Object) - Method in class jhplot.io.RecordWriter
 
writeScript(File, HPlot) - Static method in class jhplot.io.JHwriter
Write the file
writeSerialized(String) - Method in class jhplot.P0D
Write a P0D object to a serialized file
writeSerialized(String) - Method in class jhplot.P0I
Write a P0I object to a serialized file
writeSerialized(String) - Method in class jhplot.P1D
Write a P0D object to a serialized file
writeSerialized(String) - Method in class jhplot.P2D
Write a P0D object to a serialized file
writeSerialized(String) - Method in class jhplot.P3D
Write a P0D object to a serialized file
writeSerialized(String) - Method in class jhplot.PND
Write a P0D object to a serialized file
writeSerialized(String) - Method in class jhplot.PNI
Write a P0D object to a serialized file
writeShort(int) - Method in class jhplot.math.io.LEDataOutputStream
 
writeShort(int) - Method in class jhplot.math.io.LERandomAccessFile
like RandomAcessFile.writeShort.
writeTo(DataOutput) - Method in class jhplot.io.DbByteArrayOutputStream
Writes the full contents of the buffer a DataOutput stream.
writeTo(DataOutput) - Method in class jhplot.io.RecordWriter
Writes the data out to the stream without re-allocating the buffer.
writeUTF(String) - Method in class jhplot.math.io.LEDataOutputStream
 
writeUTF(String) - Method in class jhplot.math.io.LERandomAccessFile
 
writeXML(Object, String) - Static method in class jhplot.io.Serialized
Write an object to a serialized XML file.
WU - Static variable in class umontreal.iro.lecuyer.gof.GofFormat
Watson U test

X

x() - Method in class hephysics.vec.Hep3Vector
 
x() - Method in class hephysics.vec.HepLorentzVector
Get X position or Px
x() - Method in class hephysics.vec.SpacePoint
Cartesian x
xAxis() - Method in class hep.aida.ref.histogram.Histogram2D
Get the X axis.
xAxis() - Method in class hep.aida.ref.histogram.Histogram3D
Get the X axis.
xAxis() - Method in class hep.aida.ref.histogram.Profile2D
 
xAxis() - Method in interface hep.aida.tdouble.DoubleIHistogram1D
Returns the X Axis.
xAxis() - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Return the X axis.
xAxis() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Return the X axis.
xAxis() - Method in interface hep.aida.tfloat.FloatIHistogram1D
Returns the X Axis.
xAxis() - Method in interface hep.aida.tfloat.FloatIHistogram2D
Return the X axis.
xAxis() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Return the X axis.
xLog10x() - Method in class flanagan.analysis.Stat
 
xLog10x() - Method in class flanagan.math.ArrayMaths
 
xLog2x() - Method in class flanagan.analysis.Stat
 
xLog2x() - Method in class flanagan.math.ArrayMaths
 
xLogEx() - Method in class flanagan.analysis.Stat
 
xLogEx() - Method in class flanagan.math.ArrayMaths
 
xMatrix() - Method in class flanagan.analysis.PCA
 
xMatrixTranspose() - Method in class flanagan.analysis.PCA
 
xminimum() - Method in class cern.colt.list.MinMaxNumberList
Deprecated.  
xminimum() - Method in class cern.colt.list.tlong.MinMaxNumberList
Deprecated.  
xmultOuter(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Outer product of two vectors; Returns a matrix with A[i,j] = x[i] * y[j].
xmultOuter(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Outer product of two vectors; Returns a matrix with A[i,j] = x[i] * y[j].
xor(BitMatrix) - Method in class cern.colt.bitvector.BitMatrix
Performs a logical XOR of the receiver with another bit matrix.
xor(BitVector) - Method in class cern.colt.bitvector.BitVector
Performs a logical XOR of the receiver with another bit vector (A = A ^ B).
xor(BitMatrix) - Method in class cern.colt.matrix.tbit.BitMatrix
Performs a logical XOR of the receiver with another bit matrix.
xor(BitVector) - Method in class cern.colt.matrix.tbit.BitVector
Performs a logical XOR of the receiver with another bit vector (A = A ^ B).
xor - Static variable in class cern.jet.math.IntFunctions
Function that returns a ^ b.
xor(int) - Static method in class cern.jet.math.IntFunctions
Constructs a function that returns a | b.
xor - Static variable in class cern.jet.math.tint.IntFunctions
Function that returns a ^ b.
xor(int) - Static method in class cern.jet.math.tint.IntFunctions
Constructs a function that returns a | b.
xor - Static variable in class cern.jet.math.tlong.LongFunctions
Function that returns a ^ b.
xor(long) - Static method in class cern.jet.math.tlong.LongFunctions
Constructs a function that returns a | b.
xor(BitMatrix) - Method in class umontreal.iro.lecuyer.util.BitMatrix
Returns the BitMatrix resulting from the application of the xor operator on the original BitMatrix and that.
xor(BitVector) - Method in class umontreal.iro.lecuyer.util.BitVector
Returns a BitVector which is the result of the xor operator applied on this and that.
Xpos - Static variable in class jhplot.JHPlot
 
xpowSlow(DoubleMatrix2D, int) - Method in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
Linear algebraic matrix power; B = Ak <==> B = A*A*...*A.
xpowSlow(FloatMatrix2D, int) - Method in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
Linear algebraic matrix power; B = Ak <==> B = A*A*...*A.
XYChart - Class in umontreal.iro.lecuyer.charts
This class provides tools to create charts from data in a simple way.
XYChart() - Constructor for class umontreal.iro.lecuyer.charts.XYChart
 
XYLineChart - Class in umontreal.iro.lecuyer.charts
This class provides tools to create and manage curve plots.
XYLineChart() - Constructor for class umontreal.iro.lecuyer.charts.XYLineChart
Initializes a new XYLineChart instance with an empty data set.
XYLineChart(String, String, String, double[][]...) - Constructor for class umontreal.iro.lecuyer.charts.XYLineChart
Initializes a new XYLineChart instance with sets of points data.
XYLineChart(String, String, String, double[][], int) - Constructor for class umontreal.iro.lecuyer.charts.XYLineChart
Initializes a new XYLineChart instance with sets of points data.
XYLineChart(String, String, String, double[][], int, int) - Constructor for class umontreal.iro.lecuyer.charts.XYLineChart
Initializes a new XYLineChart instance using subsets of data.
XYLineChart(String, String, String, DoubleArrayList...) - Constructor for class umontreal.iro.lecuyer.charts.XYLineChart
Initializes a new XYLineChart instance with data data.
XYLineChart(String, String, String, XYSeriesCollection) - Constructor for class umontreal.iro.lecuyer.charts.XYLineChart
Initializes a new XYLineChart instance with data data.
XYListSeriesCollection - Class in umontreal.iro.lecuyer.charts
This class extends SSJXYSeriesCollection.
XYListSeriesCollection() - Constructor for class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Creates a new XYListSeriesCollection instance with an empty dataset.
XYListSeriesCollection(double[][]...) - Constructor for class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Creates a new XYListSeriesCollection instance with default parameters and given data series.
XYListSeriesCollection(double[][], int) - Constructor for class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Creates a new XYListSeriesCollection instance with default parameters and given points data.
XYListSeriesCollection(DoubleArrayList...) - Constructor for class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Creates a new XYListSeriesCollection instance with default parameters and given data.
XYListSeriesCollection(XYSeriesCollection) - Constructor for class umontreal.iro.lecuyer.charts.XYListSeriesCollection
Creates a new XYListSeriesCollection instance with default parameters and given data series.
XYX - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.
XYZ - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.
XZX - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.
XZY - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.

Y

y() - Method in class hephysics.vec.Hep3Vector
 
y() - Method in class hephysics.vec.HepLorentzVector
Get Y
y() - Method in class hephysics.vec.SpacePoint
Cartesian y
y0(double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the second kind of order 0 of the argument.
y0(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the Bessel function of the second kind of order 0 of the argument.
y1(double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the second kind of order 1 of the argument.
y1(double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the Bessel function of the second kind of order 1 of the argument.
yardToMetre(double) - Static method in class flanagan.math.Conv
 
yardToMetre(double) - Static method in class flanagan.math.Fmath
 
yAxis() - Method in class hep.aida.ref.histogram.Histogram2D
Get the Y axis.
yAxis() - Method in class hep.aida.ref.histogram.Histogram3D
Get the Y axis.
yAxis() - Method in class hep.aida.ref.histogram.Profile2D
 
yAxis() - Method in interface hep.aida.tdouble.DoubleIHistogram2D
Return the Y axis.
yAxis() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Return the Y axis.
yAxis() - Method in interface hep.aida.tfloat.FloatIHistogram2D
Return the Y axis.
yAxis() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Return the Y axis.
YListChart - Class in umontreal.iro.lecuyer.charts
This class extends the class XYLineChart.
YListChart(String, String, String, double[]...) - Constructor for class umontreal.iro.lecuyer.charts.YListChart
Initializes a new YListChart instance with set of points data.
YListChart(String, String, String, double[], int) - Constructor for class umontreal.iro.lecuyer.charts.YListChart
Initializes a new YListChart instance with a set of points data.
YListChart(String, String, String, double[][], int) - Constructor for class umontreal.iro.lecuyer.charts.YListChart
Initializes a new YListChart instance with set of points data.
YListSeriesCollection - Class in umontreal.iro.lecuyer.charts
This class extends XYListSeriesCollection.
YListSeriesCollection(double[]...) - Constructor for class umontreal.iro.lecuyer.charts.YListSeriesCollection
Creates a new YListSeriesCollection instance with default parameters and given data series.
YListSeriesCollection(double[], int) - Constructor for class umontreal.iro.lecuyer.charts.YListSeriesCollection
Creates a new YListSeriesCollection instance with default parameters and one data series.
YListSeriesCollection(double[][], int) - Constructor for class umontreal.iro.lecuyer.charts.YListSeriesCollection
Creates a new YListSeriesCollection instance with default parameters and given data series.
yn(int, double) - Static method in class cern.jet.math.Bessel
Returns the Bessel function of the second kind of order n of the argument.
yn(int, double) - Static method in class cern.jet.math.tdouble.Bessel
Returns the Bessel function of the second kind of order n of the argument.
Ypos - Static variable in class jhplot.JHPlot
 
YXY - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.
YXZ - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.
YZX - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.
YZY - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.

Z

z() - Method in class hephysics.vec.Hep3Vector
 
z() - Method in class hephysics.vec.HepLorentzVector
Get Z position or Pz
z() - Method in class hephysics.vec.SpacePoint
Cartesian z
zAssign27Neighbors(DoubleMatrix3D, Double27Function) - Method in class cern.colt.matrix.DoubleMatrix3D
27 neighbor stencil transformation.
zAssign27Neighbors(DoubleMatrix3D, Double27Function) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix3D
27 neighbor stencil transformation.
zAssign27Neighbors(DoubleMatrix3D, Double27Function) - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
27 neighbor stencil transformation.
zAssign27Neighbors(DoubleMatrix3D, Double27Function) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
zAssign27Neighbors(FloatMatrix3D, Float27Function) - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
27 neighbor stencil transformation.
zAssign27Neighbors(FloatMatrix3D, Float27Function) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
zAssign8Neighbors(DoubleMatrix2D, Double9Function) - Method in class cern.colt.matrix.DoubleMatrix2D
8 neighbor stencil transformation.
zAssign8Neighbors(DoubleMatrix2D, Double9Function) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
8 neighbor stencil transformation.
zAssign8Neighbors(DoubleMatrix2D, Double9Function) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
8 neighbor stencil transformation.
zAssign8Neighbors(DoubleMatrix2D, Double9Function) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
zAssign8Neighbors(FloatMatrix2D, Float9Function) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
8 neighbor stencil transformation.
zAssign8Neighbors(FloatMatrix2D, Float9Function) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
zAxis() - Method in class hep.aida.ref.histogram.Histogram3D
Get the Z axis.
zAxis() - Method in interface hep.aida.tdouble.DoubleIHistogram3D
Return the Z axis.
zAxis() - Method in interface hep.aida.tfloat.FloatIHistogram3D
Return the Z axis.
zdemo1() - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates advanced sorting.
zdemo1() - Static method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Demonstrates advanced sorting.
zdemo1() - Static method in class cern.colt.matrix.tfloat.algo.FloatSorting
Demonstrates advanced sorting.
zdemo2() - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates advanced sorting.
zdemo2() - Static method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Demonstrates advanced sorting.
zdemo2() - Static method in class cern.colt.matrix.tfloat.algo.FloatSorting
Demonstrates advanced sorting.
zdemo3() - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates advanced sorting.
zdemo3() - Static method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Demonstrates advanced sorting.
zdemo3() - Static method in class cern.colt.matrix.tfloat.algo.FloatSorting
Demonstrates advanced sorting.
zdemo5(int, int, boolean) - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates sorting with precomputation of aggregates (median and sum of logarithms).
zdemo5(int, int, boolean) - Static method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Demonstrates sorting with precomputation of aggregates (median and sum of logarithms).
zdemo5(int, int, boolean) - Static method in class cern.colt.matrix.tfloat.algo.FloatSorting
Demonstrates sorting with precomputation of aggregates (median and sum of logarithms).
zdemo6() - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates advanced sorting.
zdemo6() - Static method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Demonstrates advanced sorting.
zdemo6() - Static method in class cern.colt.matrix.tfloat.algo.FloatSorting
Demonstrates advanced sorting.
zdemo7(int, int, boolean) - Static method in class cern.colt.matrix.doublealgo.Sorting
Demonstrates sorting with precomputation of aggregates, comparing mergesort with quicksort.
zdemo7(int, int, boolean) - Static method in class cern.colt.matrix.tdouble.algo.DoubleSorting
Demonstrates sorting with precomputation of aggregates, comparing mergesort with quicksort.
zdemo7(int, int, boolean) - Static method in class cern.colt.matrix.tfloat.algo.FloatSorting
Demonstrates sorting with precomputation of aggregates, comparing mergesort with quicksort.
zdemo8(int) - Static method in class cern.colt.matrix.tdouble.algo.DoubleSorting
 
zdemo8(int) - Static method in class cern.colt.matrix.tfloat.algo.FloatSorting
 
zDotProduct(DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(DoubleMatrix1D, int, int) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(DoubleMatrix1D, int, int, IntArrayList) - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(DoubleMatrix1D, int, int) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns the dot product of two vectors x and y.
zDotProduct(DComplexMatrix1D, int, int) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns the dot product of two vectors x and y.
zDotProduct(DComplexMatrix1D, int, int, IntArrayList) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns the dot product of two vectors x and y.
zDotProduct(DComplexMatrix1D, int, int) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
zDotProduct(DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(DoubleMatrix1D, int, int) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(DoubleMatrix1D, int, int, IntArrayList) - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(DoubleMatrix1D, int, int) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
zDotProduct(FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns the dot product of two vectors x and y.
zDotProduct(FComplexMatrix1D, int, int) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns the dot product of two vectors x and y.
zDotProduct(FComplexMatrix1D, int, int, IntArrayList) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns the dot product of two vectors x and y.
zDotProduct(FComplexMatrix1D, int, int) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
zDotProduct(FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(FloatMatrix1D, int, int) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(FloatMatrix1D, int, int, IntArrayList) - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(FloatMatrix1D, int, int) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
zDotProduct(IntMatrix1D) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
zDotProduct(IntMatrix1D, int, int) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
zDotProduct(IntMatrix1D) - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(IntMatrix1D, int, int) - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(IntMatrix1D, int, int, IntArrayList) - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(LongMatrix1D) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
zDotProduct(LongMatrix1D, int, int) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
zDotProduct(LongMatrix1D) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(LongMatrix1D, int, int) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
zDotProduct(LongMatrix1D, int, int, IntArrayList) - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns the dot product of two vectors x and y, which is Sum(x[i]*y[i]).
ZERO - Static variable in class cern.colt.matrix.linalg.Algebra
A default Algebra object; has Property.ZERO attached for tolerance.
ZERO - Static variable in class cern.colt.matrix.linalg.Property
A Property object with tolerance()==0.0.
ZERO - Static variable in class cern.colt.matrix.tdcomplex.algo.DComplexProperty
A Property object with tolerance()==0.0.
ZERO - Static variable in class cern.colt.matrix.tdouble.algo.DenseDoubleAlgebra
A default Algebra object; has DoubleProperty.ZERO attached for tolerance.
ZERO - Static variable in class cern.colt.matrix.tdouble.algo.DoubleProperty
A Property object with tolerance()==0.0.
ZERO - Static variable in class cern.colt.matrix.tdouble.algo.SparseDoubleAlgebra
A default Algebra object; has DoubleProperty.ZERO attached for tolerance.
ZERO - Static variable in class cern.colt.matrix.tfcomplex.algo.FComplexProperty
A Property object with tolerance()==0.0.
ZERO - Static variable in class cern.colt.matrix.tfloat.algo.DenseFloatAlgebra
A default Algebra object; has FloatProperty.ZERO attached for tolerance.
ZERO - Static variable in class cern.colt.matrix.tfloat.algo.FloatProperty
A Property object with tolerance()==0.0.
ZERO - Static variable in class cern.colt.matrix.tfloat.algo.SparseFloatAlgebra
A default Algebra object; has FloatProperty.ZERO attached for tolerance.
zero() - Static method in class flanagan.analysis.ErrorProp
 
zero(int, int) - Static method in class flanagan.interpolation.BiCubicSpline
 
zero(int) - Static method in class flanagan.interpolation.CubicSpline
 
zero(int) - Static method in class flanagan.interpolation.CubicSplineFast
 
zero(int) - Static method in class flanagan.interpolation.CubicSplineShort
 
zero(int, int, int) - Static method in class flanagan.interpolation.TriCubicSpline
 
ZERO - Static variable in class org.apache.commons.math.analysis.ComposableFunction
The constant function always returning 0.
ZERO - Static variable in class org.apache.commons.math.complex.Complex
A complex number representing "0.0 + 0.0i"
ZERO - Static variable in class org.apache.commons.math.fraction.BigFraction
A fraction representing "0".
ZERO - Static variable in class org.apache.commons.math.fraction.Fraction
A fraction representing "0".
ZERO - Static variable in class org.apache.commons.math.geometry.Vector3D
Null vector (coordinates: 0, 0, 0).
ZERO - Static variable in class org.apache.commons.math.util.BigReal
A big real representing 0.
ZeroException - Exception in org.apache.commons.math.exception
Exception to be thrown when zero is provided where it is not allowed.
ZeroException() - Constructor for exception org.apache.commons.math.exception.ZeroException
Construct the exception.
ZeroException(Localizable) - Constructor for exception org.apache.commons.math.exception.ZeroException
Construct the exception with a specific context.
Zeta - Class in cern.jet.random.tdouble
Zeta distribution.
Zeta(double, double, DoubleRandomEngine) - Constructor for class cern.jet.random.tdouble.Zeta
Constructs a Zeta distribution.
Zeta - Class in cern.jet.random
Zeta distribution.
Zeta(double, double, RandomEngine) - Constructor for class cern.jet.random.Zeta
Constructs a Zeta distribution.
ZigZagLine(float, float) - Static method in class jhplot.jadraw.Diagram
Get a zig zag object
ZipfDistribution - Interface in org.apache.commons.math.distribution
The Zipf (or zeta) Distribution.
ZipfDistributionImpl - Class in org.apache.commons.math.distribution
Implementation for the ZipfDistribution.
ZipfDistributionImpl(int, double) - Constructor for class org.apache.commons.math.distribution.ZipfDistributionImpl
Create a new Zipf distribution with the given number of elements and exponent.
zMult(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.DoubleMatrix2D
Linear algebraic matrix-vector multiplication; z = A * y; Equivalent to return A.zMult(y,z,1,0);
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.DoubleMatrix2D
Linear algebraic matrix-vector multiplication; z = alpha * A * y + beta*z.
zMult(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.DoubleMatrix2D
Linear algebraic matrix-matrix multiplication; C = A x B; Equivalent to A.zMult(B,C,1,0,false,false).
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.DoubleMatrix2D
Linear algebraic matrix-matrix multiplication; C = alpha * A x B + beta*C.
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
 
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.impl.RCDoubleMatrix2D
 
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.impl.SparseDoubleMatrix2D
 
zMult(DComplexMatrix1D, DComplexMatrix1D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Linear algebraic matrix-vector multiplication; z = A * y; Equivalent to return A.zMult(y,z,1,0);
zMult(DComplexMatrix1D, DComplexMatrix1D, double[], double[], boolean) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Linear algebraic matrix-vector multiplication; z = alpha * A * y + beta*z.
zMult(DComplexMatrix2D, DComplexMatrix2D) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Linear algebraic matrix-matrix multiplication; C = A x B; Equivalent to A.zMult(B,C,1,0,false,false).
zMult(DComplexMatrix2D, DComplexMatrix2D, double[], double[], boolean, boolean) - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Linear algebraic matrix-matrix multiplication; C = alpha * A x B + beta*C.
zMult(DComplexMatrix2D, DComplexMatrix2D, double[], double[], boolean, boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
zMult(DComplexMatrix1D, DComplexMatrix1D, double[], double[], boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
zMult(DComplexMatrix2D, DComplexMatrix2D, double[], double[], boolean, boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
zMult(DComplexMatrix1D, DComplexMatrix1D, double[], double[], boolean) - Method in class cern.colt.matrix.tdcomplex.impl.DiagonalDComplexMatrix2D
 
zMult(DComplexMatrix1D, DComplexMatrix1D, double[], double[], boolean) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
zMult(DComplexMatrix2D, DComplexMatrix2D, double[], double[], boolean, boolean) - Method in class cern.colt.matrix.tdcomplex.impl.SparseCCDComplexMatrix2D
 
zMult(DComplexMatrix1D, DComplexMatrix1D, double[], double[], boolean) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
zMult(DComplexMatrix2D, DComplexMatrix2D, double[], double[], boolean, boolean) - Method in class cern.colt.matrix.tdcomplex.impl.SparseRCDComplexMatrix2D
 
zMult(DoubleMatrix1D, DoubleMatrix1D) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Linear algebraic matrix-vector multiplication; z = A * y; Equivalent to return A.zMult(y,z,1,0);
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Linear algebraic matrix-vector multiplication; z = alpha * A * y + beta*z.
zMult(DoubleMatrix2D, DoubleMatrix2D) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Linear algebraic matrix-matrix multiplication; C = A x B; Equivalent to A.zMult(B,C,1,0,false,false).
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Linear algebraic matrix-matrix multiplication; C = alpha * A x B + beta*C.
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.tdouble.impl.DiagonalDoubleMatrix2D
 
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.tdouble.impl.SparseCCDoubleMatrix2D
 
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.tdouble.impl.SparseDoubleMatrix2D
 
zMult(DoubleMatrix1D, DoubleMatrix1D, double, double, boolean) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
zMult(DoubleMatrix2D, DoubleMatrix2D, double, double, boolean, boolean) - Method in class cern.colt.matrix.tdouble.impl.SparseRCDoubleMatrix2D
 
zMult(FComplexMatrix1D, FComplexMatrix1D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Linear algebraic matrix-vector multiplication; z = A * y; Equivalent to return A.zMult(y,z,1,0);
zMult(FComplexMatrix1D, FComplexMatrix1D, float[], float[], boolean) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Linear algebraic matrix-vector multiplication; z = alpha * A * y + beta*z.
zMult(FComplexMatrix2D, FComplexMatrix2D) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Linear algebraic matrix-matrix multiplication; C = A x B; Equivalent to A.zMult(B,C,1,0,false,false).
zMult(FComplexMatrix2D, FComplexMatrix2D, float[], float[], boolean, boolean) - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Linear algebraic matrix-matrix multiplication; C = alpha * A x B + beta*C.
zMult(FComplexMatrix2D, FComplexMatrix2D, float[], float[], boolean, boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
zMult(FComplexMatrix1D, FComplexMatrix1D, float[], float[], boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
zMult(FComplexMatrix2D, FComplexMatrix2D, float[], float[], boolean, boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
zMult(FComplexMatrix1D, FComplexMatrix1D, float[], float[], boolean) - Method in class cern.colt.matrix.tfcomplex.impl.DiagonalFComplexMatrix2D
 
zMult(FComplexMatrix1D, FComplexMatrix1D, float[], float[], boolean) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
zMult(FComplexMatrix2D, FComplexMatrix2D, float[], float[], boolean, boolean) - Method in class cern.colt.matrix.tfcomplex.impl.SparseCCFComplexMatrix2D
 
zMult(FComplexMatrix1D, FComplexMatrix1D, float[], float[], boolean) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
zMult(FComplexMatrix2D, FComplexMatrix2D, float[], float[], boolean, boolean) - Method in class cern.colt.matrix.tfcomplex.impl.SparseRCFComplexMatrix2D
 
zMult(FloatMatrix1D, FloatMatrix1D) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Linear algebraic matrix-vector multiplication; z = A * y; Equivalent to return A.zMult(y,z,1,0);
zMult(FloatMatrix1D, FloatMatrix1D, float, float, boolean) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Linear algebraic matrix-vector multiplication; z = alpha * A * y + beta*z.
zMult(FloatMatrix2D, FloatMatrix2D) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Linear algebraic matrix-matrix multiplication; C = A x B; Equivalent to A.zMult(B,C,1,0,false,false).
zMult(FloatMatrix2D, FloatMatrix2D, float, float, boolean, boolean) - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Linear algebraic matrix-matrix multiplication; C = alpha * A x B + beta*C.
zMult(FloatMatrix1D, FloatMatrix1D, float, float, boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
zMult(FloatMatrix2D, FloatMatrix2D, float, float, boolean, boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
zMult(FloatMatrix1D, FloatMatrix1D, float, float, boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
zMult(FloatMatrix2D, FloatMatrix2D, float, float, boolean, boolean) - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
zMult(FloatMatrix1D, FloatMatrix1D, float, float, boolean) - Method in class cern.colt.matrix.tfloat.impl.DiagonalFloatMatrix2D
 
zMult(FloatMatrix1D, FloatMatrix1D, float, float, boolean) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
zMult(FloatMatrix2D, FloatMatrix2D, float, float, boolean, boolean) - Method in class cern.colt.matrix.tfloat.impl.SparseCCFloatMatrix2D
 
zMult(FloatMatrix1D, FloatMatrix1D, float, float, boolean) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
zMult(FloatMatrix2D, FloatMatrix2D, float, float, boolean, boolean) - Method in class cern.colt.matrix.tfloat.impl.SparseFloatMatrix2D
 
zMult(FloatMatrix1D, FloatMatrix1D, float, float, boolean) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
zMult(FloatMatrix2D, FloatMatrix2D, float, float, boolean, boolean) - Method in class cern.colt.matrix.tfloat.impl.SparseRCFloatMatrix2D
 
zMult(IntMatrix1D, IntMatrix1D, int, int, boolean) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
zMult(IntMatrix2D, IntMatrix2D, int, int, boolean, boolean) - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
zMult(IntMatrix1D, IntMatrix1D, int, int, boolean) - Method in class cern.colt.matrix.tint.impl.DiagonalIntMatrix2D
 
zMult(IntMatrix1D, IntMatrix1D, int, int, boolean) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
zMult(IntMatrix2D, IntMatrix2D, int, int, boolean, boolean) - Method in class cern.colt.matrix.tint.impl.SparseCCIntMatrix2D
 
zMult(IntMatrix1D, IntMatrix1D, int, int, boolean) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
zMult(IntMatrix2D, IntMatrix2D, int, int, boolean, boolean) - Method in class cern.colt.matrix.tint.impl.SparseIntMatrix2D
 
zMult(IntMatrix1D, IntMatrix1D, int, int, boolean) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
zMult(IntMatrix2D, IntMatrix2D, int, int, boolean, boolean) - Method in class cern.colt.matrix.tint.impl.SparseRCIntMatrix2D
 
zMult(IntMatrix1D, IntMatrix1D) - Method in class cern.colt.matrix.tint.IntMatrix2D
Linear algebraic matrix-vector multiplication; z = A * y; Equivalent to return A.zMult(y,z,1,0);
zMult(IntMatrix1D, IntMatrix1D, int, int, boolean) - Method in class cern.colt.matrix.tint.IntMatrix2D
Linear algebraic matrix-vector multiplication; z = alpha * A * y + beta*z.
zMult(IntMatrix2D, IntMatrix2D) - Method in class cern.colt.matrix.tint.IntMatrix2D
Linear algebraic matrix-matrix multiplication; C = A x B; Equivalent to A.zMult(B,C,1,0,false,false).
zMult(IntMatrix2D, IntMatrix2D, int, int, boolean, boolean) - Method in class cern.colt.matrix.tint.IntMatrix2D
Linear algebraic matrix-matrix multiplication; C = alpha * A x B + beta*C.
zMult(LongMatrix1D, LongMatrix1D, long, long, boolean) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
zMult(LongMatrix2D, LongMatrix2D, long, long, boolean, boolean) - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
zMult(LongMatrix1D, LongMatrix1D, long, long, boolean) - Method in class cern.colt.matrix.tlong.impl.DiagonalLongMatrix2D
 
zMult(LongMatrix1D, LongMatrix1D, long, long, boolean) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
zMult(LongMatrix2D, LongMatrix2D, long, long, boolean, boolean) - Method in class cern.colt.matrix.tlong.impl.SparseCCLongMatrix2D
 
zMult(LongMatrix1D, LongMatrix1D, long, long, boolean) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
zMult(LongMatrix2D, LongMatrix2D, long, long, boolean, boolean) - Method in class cern.colt.matrix.tlong.impl.SparseLongMatrix2D
 
zMult(LongMatrix1D, LongMatrix1D, long, long, boolean) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
zMult(LongMatrix2D, LongMatrix2D, long, long, boolean, boolean) - Method in class cern.colt.matrix.tlong.impl.SparseRCLongMatrix2D
 
zMult(LongMatrix1D, LongMatrix1D) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Linear algebraic matrix-vector multiplication; z = A * y; Equivalent to return A.zMult(y,z,1,0);
zMult(LongMatrix1D, LongMatrix1D, long, long, boolean) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Linear algebraic matrix-vector multiplication; z = alpha * A * y + beta*z.
zMult(LongMatrix2D, LongMatrix2D) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Linear algebraic matrix-matrix multiplication; C = A x B; Equivalent to A.zMult(B,C,1,0,false,false).
zMult(LongMatrix2D, LongMatrix2D, long, long, boolean, boolean) - Method in class cern.colt.matrix.tlong.LongMatrix2D
Linear algebraic matrix-matrix multiplication; C = alpha * A x B + beta*C.
zoom(double, double, double, double) - Method in class jhplot.SPlot
Zoom in or out to the specified rectangle.
zSum() - Method in class cern.colt.matrix.DoubleMatrix1D
Returns the sum of all cells; Sum( x[i] ).
zSum() - Method in class cern.colt.matrix.DoubleMatrix2D
Returns the sum of all cells; Sum( x[i,j] ).
zSum() - Method in class cern.colt.matrix.DoubleMatrix3D
Returns the sum of all cells; Sum( x[i,j,k] ).
zSum() - Method in class cern.colt.matrix.impl.DenseDoubleMatrix1D
Returns the sum of all cells; Sum( x[i] ).
zSum() - Method in class cern.colt.matrix.impl.DenseDoubleMatrix2D
Returns the sum of all cells; Sum( x[i,j] ).
zSum() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix1D
Returns the sum of all cells.
zSum() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix2D
Returns the sum of all cells.
zSum() - Method in class cern.colt.matrix.tdcomplex.DComplexMatrix3D
Returns the sum of all cells; Sum( x[i,j,k] ).
zSum() - Method in class cern.colt.matrix.tdcomplex.impl.DenseColumnDComplexMatrix2D
 
zSum() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix1D
 
zSum() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix2D
 
zSum() - Method in class cern.colt.matrix.tdcomplex.impl.DenseDComplexMatrix3D
 
zSum() - Method in class cern.colt.matrix.tdouble.DoubleMatrix1D
Returns the sum of all cells; Sum( x[i] ).
zSum() - Method in class cern.colt.matrix.tdouble.DoubleMatrix2D
Returns the sum of all cells; Sum( x[i,j] ).
zSum() - Method in class cern.colt.matrix.tdouble.DoubleMatrix3D
Returns the sum of all cells; Sum( x[i,j,k] ).
zSum() - Method in class cern.colt.matrix.tdouble.impl.DenseColumnDoubleMatrix2D
 
zSum() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix1D
 
zSum() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix2D
 
zSum() - Method in class cern.colt.matrix.tdouble.impl.DenseDoubleMatrix3D
 
zSum() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix1D
Returns the sum of all cells.
zSum() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix2D
Returns the sum of all cells.
zSum() - Method in class cern.colt.matrix.tfcomplex.FComplexMatrix3D
Returns the sum of all cells; Sum( x[i,j,k] ).
zSum() - Method in class cern.colt.matrix.tfcomplex.impl.DenseColumnFComplexMatrix2D
 
zSum() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix1D
 
zSum() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix2D
 
zSum() - Method in class cern.colt.matrix.tfcomplex.impl.DenseFComplexMatrix3D
 
zSum() - Method in class cern.colt.matrix.tfloat.FloatMatrix1D
Returns the sum of all cells; Sum( x[i] ).
zSum() - Method in class cern.colt.matrix.tfloat.FloatMatrix2D
Returns the sum of all cells; Sum( x[i,j] ).
zSum() - Method in class cern.colt.matrix.tfloat.FloatMatrix3D
Returns the sum of all cells; Sum( x[i,j,k] ).
zSum() - Method in class cern.colt.matrix.tfloat.impl.DenseColumnFloatMatrix2D
 
zSum() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix1D
 
zSum() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix2D
 
zSum() - Method in class cern.colt.matrix.tfloat.impl.DenseFloatMatrix3D
 
zSum() - Method in class cern.colt.matrix.tint.impl.DenseColumnIntMatrix2D
 
zSum() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix1D
 
zSum() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix2D
 
zSum() - Method in class cern.colt.matrix.tint.impl.DenseIntMatrix3D
 
zSum() - Method in class cern.colt.matrix.tint.IntMatrix1D
Returns the sum of all cells; Sum( x[i] ).
zSum() - Method in class cern.colt.matrix.tint.IntMatrix2D
Returns the sum of all cells; Sum( x[i,j] ).
zSum() - Method in class cern.colt.matrix.tint.IntMatrix3D
Returns the sum of all cells; Sum( x[i,j,k] ).
zSum() - Method in class cern.colt.matrix.tlong.impl.DenseColumnLongMatrix2D
 
zSum() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix1D
 
zSum() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix2D
 
zSum() - Method in class cern.colt.matrix.tlong.impl.DenseLongMatrix3D
 
zSum() - Method in class cern.colt.matrix.tlong.LongMatrix1D
Returns the sum of all cells; Sum( x[i] ).
zSum() - Method in class cern.colt.matrix.tlong.LongMatrix2D
Returns the sum of all cells; Sum( x[i,j] ).
zSum() - Method in class cern.colt.matrix.tlong.LongMatrix3D
Returns the sum of all cells; Sum( x[i,j,k] ).
ZXY - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.
ZXZ - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.
ZYX - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Cardan angles.
ZYZ - Static variable in class org.apache.commons.math.geometry.RotationOrder
Set of Euler angles.

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

jHepWork 3.0 ©