All Classes Interface Summary Class Summary
Class |
Description |
AbstractBin |
Abstract base class for all arbitrary-dimensional bins consumes double elements.
|
AbstractBin1D |
Abstract base class for all 1-dimensional bins consumes double elements.
|
AbstractBooleanList |
Abstract base class for resizable lists holding boolean elements; abstract.
|
AbstractByteList |
Abstract base class for resizable lists holding byte elements; abstract.
|
AbstractCharList |
Abstract base class for resizable lists holding char elements; abstract.
|
AbstractCollection |
Abstract base class for resizable collections holding objects or primitive data types such as int , float , etc.
|
AbstractContinousDistribution |
Abstract base class for all continous distributions.
|
AbstractDiscreteDistribution |
Abstract base class for all discrete distributions.
|
AbstractDistribution |
Abstract base class for all random distributions.
|
AbstractDoubleIntMap |
Abstract base class for hash maps holding (key,value) associations of type (double-->int).
|
AbstractDoubleList |
Abstract base class for resizable lists holding double elements; abstract.
|
AbstractFloatList |
Abstract base class for resizable lists holding float elements; abstract.
|
AbstractFormatter |
Abstract base class for flexible, well human readable matrix print formatting.
|
AbstractHistogram1D |
Abstract base class extracting and implementing most of the redundancy of the interface.
|
AbstractHistogram2D |
Abstract base class extracting and implementing most of the redundancy of the interface.
|
AbstractHistogram3D |
Abstract base class extracting and implementing most of the redundancy of the interface.
|
AbstractIntDoubleMap |
Abstract base class for hash maps holding (key,value) associations of type (int-->double).
|
AbstractIntIntMap |
Abstract base class for hash maps holding (key,value) associations of type (int-->int).
|
AbstractIntList |
Abstract base class for resizable lists holding int elements; abstract.
|
AbstractIntObjectMap |
Abstract base class for hash maps holding (key,value) associations of type (int-->Object).
|
AbstractList |
Abstract base class for resizable lists holding objects or primitive data types such as int , float , etc.
|
AbstractLongList |
Abstract base class for resizable lists holding long elements; abstract.
|
AbstractLongObjectMap |
Abstract base class for hash maps holding (key,value) associations of type (long-->Object).
|
AbstractMap |
Abstract base class for hash maps holding objects or primitive data types such as int , float , etc.
|
AbstractMatrix |
Abstract base class for arbitrary-dimensional matrices holding objects or primitive data types such as int , float , etc.
|
AbstractMatrix1D |
Abstract base class for 1-d matrices (aka vectors) holding objects or primitive data types such as int , double , etc.
|
AbstractMatrix2D |
Abstract base class for 2-d matrices holding objects or primitive data types such as int , double , etc.
|
AbstractMatrix3D |
Abstract base class for 3-d matrices holding objects or primitive data types such as int , double , etc.
|
AbstractShortList |
Abstract base class for resizable lists holding short elements; abstract.
|
Algebra |
Linear algebraic matrix operations operating on DoubleMatrix2D ; concentrates most functionality of this package.
|
Algebraic |
Not yet commented.
|
Arithmetic |
Arithmetic functions.
|
Arrays |
Array manipulations; complements java.util.Arrays.
|
Benchmark |
Benchmarks the classes of this package.
|
Benchmark |
Benchmarks the performance of matrix algorithms.
|
Benchmark |
Benchmarks random number generation from various distributions as well as PDF and CDF lookups.
|
Benchmark |
Benchmarks the performance of the currently provided uniform pseudo-random number generation engines.
|
BenchmarkKernel |
Not yet documented.
|
BenchmarkMatrix |
Configurable matrix benchmark.
|
BenchmarkMatrix2D |
Benchmarks the performance of matrices.
|
Bessel |
Bessel and Airy functions.
|
Beta |
|
BinBinFunction1D |
Interface that represents a function object: a function that takes
two bins as arguments and returns a single value.
|
BinFunction1D |
Interface that represents a function object: a function that takes
two bins as arguments and returns a single value.
|
BinFunctions1D |
Function objects computing dynamic bin aggregations; to be passed to generic methods.
|
Binomial |
|
BitMatrix |
Fixed sized (non resizable) n*m bit matrix.
|
BitVector |
Fixed sized (non resizable) bitvector.
|
Blas |
Subset of the BLAS (Basic Linear Algebra System);
High quality "building block" routines for performing basic vector and matrix operations.
|
BooleanArrayList |
Resizable list holding boolean elements; implemented with arrays.
|
BooleanProcedure |
Interface that represents a procedure object: a procedure that takes
a single argument and does not return a value.
|
BreitWigner |
|
BreitWignerMeanSquare |
|
Buffer |
A buffer holding elements; internally used for computing approximate quantiles.
|
BufferSet |
An abstract set of buffers; internally used for computing approximate quantiles.
|
ByteArrayList |
Resizable list holding byte elements; implemented with arrays.
|
ByteComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
ByteProcedure |
Interface that represents a procedure object: a procedure that takes
a single argument and does not return a value.
|
CharArrayList |
Resizable list holding char elements; implemented with arrays.
|
CharComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
CharProcedure |
Interface that represents a procedure object: a procedure that takes
a single argument and does not return a value.
|
ChiSquare |
|
CholeskyDecomposition |
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.
|
Complex |
Not yet commented.
|
Constants |
Defines some useful constants.
|
Converter |
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.
|
DelegateDoubleMatrix1D |
1-d matrix holding double elements; either a view wrapping another 2-d matrix and therefore delegating calls to it.
|
DenseDoubleMatrix1D |
Dense 1-d matrix (aka vector) holding double elements.
|
DenseDoubleMatrix2D |
Dense 2-d matrix holding double elements.
|
DenseDoubleMatrix3D |
Dense 3-d matrix holding double elements.
|
DenseObjectMatrix1D |
Dense 1-d matrix (aka vector) holding Object elements.
|
DenseObjectMatrix2D |
Dense 2-d matrix holding Object elements.
|
DenseObjectMatrix3D |
Dense 3-d matrix holding Object elements.
|
Descriptive |
Basic descriptive statistics.
|
Diagonal |
For diagonal matrices we can often do better.
|
DistinctNumberList |
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.
|
Distributions |
Contains methods for conveniently generating pseudo-random numbers from special distributions such as the Burr, Cauchy, Erlang, Geometric, Lambda, Laplace, Logistic, Weibull, etc.
|
Double27Function |
Interface that represents a function object: a function that takes
27 arguments and returns a single value.
|
Double2DProcedure |
|
Double5Function |
Interface that represents a function object: a function that takes
5 arguments and returns a single value.
|
Double9Function |
Interface that represents a function object: a function that takes
9 arguments and returns a single value.
|
DoubleArrayList |
Resizable list holding double elements; implemented with arrays.
|
DoubleBuffer |
Fixed sized (non resizable) streaming buffer connected to a target DoubleBufferConsumer to which data is automatically flushed upon buffer overflow.
|
DoubleBuffer |
A buffer holding double elements; internally used for computing approximate quantiles.
|
DoubleBuffer2D |
Fixed sized (non resizable) streaming buffer connected to a target DoubleBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
|
DoubleBuffer2DConsumer |
Target of a streaming DoubleBuffer2D into which data is flushed upon buffer overflow.
|
DoubleBuffer3D |
Fixed sized (non resizable) streaming buffer connected to a target DoubleBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
|
DoubleBuffer3DConsumer |
Target of a streaming DoubleBuffer3D into which data is flushed upon buffer overflow.
|
DoubleBufferConsumer |
Target of a streaming DoubleBuffer into which data is flushed upon buffer overflow.
|
DoubleBufferSet |
A set of buffers holding double elements; internally used for computing approximate quantiles.
|
DoubleComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
DoubleDoubleFunction |
Interface that represents a function object: a function that takes
two arguments and returns a single value.
|
DoubleDoubleProcedure |
Interface that represents a procedure object: a procedure that takes
two arguments and does not return a value.
|
DoubleFactory1D |
Factory for convenient construction of 1-d matrices holding double cells.
|
DoubleFactory2D |
Factory for convenient construction of 2-d matrices holding double
cells.
|
DoubleFactory3D |
Factory for convenient construction of 3-d matrices holding double cells.
|
DoubleFunction |
Interface that represents a function object: a function that takes
a single argument and returns a single value.
|
DoubleIntProcedure |
Interface that represents a procedure object: a procedure that takes
two arguments and does not return a value.
|
DoubleListAdapter |
Adapter that permits an AbstractDoubleList to be viewed and treated as a JDK 1.2 AbstractList .
|
DoubleMatrix1D |
Abstract base class for 1-d matrices (aka vectors) holding double elements.
|
DoubleMatrix1DComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
DoubleMatrix1DProcedure |
Interface that represents a condition or procedure object: takes
a single argument and returns a boolean value.
|
DoubleMatrix2D |
Abstract base class for 2-d matrices holding double elements.
|
DoubleMatrix2DComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
DoubleMatrix2DProcedure |
Interface that represents a condition or procedure object: takes
a single argument and returns a boolean value.
|
DoubleMatrix3D |
Abstract base class for 3-d matrices holding double elements.
|
DoubleMatrix3DProcedure |
Interface that represents a condition or procedure object: takes
a single argument and returns a boolean value.
|
DoubleProcedure |
Interface that represents a procedure object: a procedure that takes
a single argument and does not return a value.
|
DoubleQuantileEstimator |
The abstract base class for approximate quantile finders computing quantiles over a sequence of double elements.
|
DoubleQuantileFinder |
The interface shared by all quantile finders, no matter if they are exact or approximate.
|
DRand |
Quick medium quality uniform pseudo-random number generator.
|
DynamicBin1D |
1-dimensional rebinnable bin holding double elements;
Efficiently computes advanced statistics of data sequences.
|
EigenvalueDecomposition |
Eigenvalues and eigenvectors of a real matrix A.
|
Elliptic |
Not yet commented.
|
Empirical |
Empirical distribution.
|
EmpiricalWalker |
Discrete Empirical distribution (pdf's can be specified).
|
EquiDepthHistogram |
Read-only equi-depth histogram for selectivity estimation.
|
ExactDoubleQuantileFinder |
Exact quantile finding algorithm for known and unknown N requiring large main memory; computes quantiles over a sequence of double elements.
|
Exponential |
Exponential functions.
|
Exponential |
|
ExponentialIntegral |
Not yet commented.
|
ExponentialPower |
Exponential Power distribution.
|
FixedAxis |
Fixed-width axis; A reference implementation of hep.aida.IAxis.
|
FloatArrayList |
Resizable list holding float elements; implemented with arrays.
|
FloatComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
FloatListAdapter |
Adapter that permits an AbstractFloatList to be viewed and treated as a JDK 1.2 AbstractList .
|
FloatProcedure |
Interface that represents a procedure object: a procedure that takes
a single argument and does not return a value.
|
Format |
A class for formatting numbers that follows printf conventions.
|
Formatter |
Flexible, well human readable matrix print formatting; By default decimal point aligned.
|
Formatter |
Flexible, well human readable matrix print formatting.
|
Former |
Formats a double into a string (like sprintf in C).
|
FormerFactory |
Factory producing implementations of Former via method create();
Implementations of can use existing libraries such as corejava.PrintfFormat or corejava.Format or other.
|
Fun |
Contains various mathematical helper methods.
|
Functions |
Function objects to be passed to generic methods.
|
Gamma |
|
Gamma |
Gamma and Beta functions.
|
GenericPermuting |
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 |
Generically sorts arbitrary shaped data (for example multiple arrays, 1,2 or 3-d matrices, and so on) using a
quicksort or mergesort.
|
GenericSortingTest |
Demonstrates how to use Sort .
|
HashFunctions |
Provides various hash functions.
|
Histogram |
Base class for Histogram1D and Histogram2D.
|
Histogram1D |
A reference implementation of hep.aida.IHistogram1D.
|
Histogram2D |
A reference implementation of hep.aida.IHistogram2D.
|
Histogram3D |
A reference implementation of hep.aida.IHistogram3D.
|
Hyperbolic |
Hyperbolic distribution.
|
HyperGeometric |
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.
|
IAxis |
An IAxis represents a binned histogram axis.
|
IHistogram |
A common base interface for IHistogram1D, IHistogram2D and IHistogram3D.
|
IHistogram1D |
A Java interface corresponding to the AIDA 1D Histogram.
|
IHistogram2D |
A Java interface corresponding to the AIDA 2D Histogram.
|
IHistogram3D |
A Java interface corresponding to the AIDA 3D Histogram.
|
IntArrayList |
Resizable list holding int elements; implemented with arrays.
|
IntBuffer |
Fixed sized (non resizable) streaming buffer connected to a target IntBufferConsumer to which data is automatically flushed upon buffer overflow.
|
IntBuffer2D |
Fixed sized (non resizable) streaming buffer connected to a target IntBuffer2DConsumer to which data is automatically flushed upon buffer overflow.
|
IntBuffer2DConsumer |
Target of a streaming IntBuffer2D into which data is flushed upon buffer overflow.
|
IntBuffer3D |
Fixed sized (non resizable) streaming buffer connected to a target IntBuffer3DConsumer to which data is automatically flushed upon buffer overflow.
|
IntBuffer3DConsumer |
Target of a streaming IntBuffer3D into which data is flushed upon buffer overflow.
|
IntBufferConsumer |
Target of a streaming IntBuffer into which data is flushed upon buffer overflow.
|
IntComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
IntDoubleFunction |
Interface that represents a function object: a function that takes two arguments.
|
IntDoubleProcedure |
Interface that represents a procedure object: a procedure that takes
two arguments and does not return a value.
|
IntFunction |
Interface that represents a function object: a function that takes
a single argument and returns a single value.
|
IntFunctions |
Integer Function objects to be passed to generic methods.
|
IntIntDoubleFunction |
Interface that represents a function object: a function that takes three arguments.
|
IntIntDoubleProcedure |
Interface that represents a procedure object: a procedure that takes
three arguments and does not return a value.
|
IntIntFunction |
Interface that represents a function object: a function that takes
two arguments and returns a single value.
|
IntIntIntProcedure |
Interface that represents a procedure object: a procedure that takes
three arguments and does not return a value.
|
IntIntProcedure |
Interface that represents a procedure object: a procedure that takes
two arguments and does not return a value.
|
IntListAdapter |
Adapter that permits an AbstractIntList to be viewed and treated as a JDK 1.2 AbstractList .
|
IntObjectProcedure |
Interface that represents a procedure object: a procedure that takes
two arguments and does not return a value.
|
IntProcedure |
Interface that represents a procedure object: a procedure that takes
a single argument and does not return a value.
|
KnownDoubleQuantileEstimator |
Approximate quantile finding algorithm for known N requiring only one pass and little main memory; computes quantiles over a sequence of double elements.
|
Logarithmic |
Logarithmic distribution.
|
LongArrayList |
Resizable list holding long elements; implemented with arrays.
|
LongComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
LongListAdapter |
Adapter that permits an AbstractLongList to be viewed and treated as a JDK 1.2 AbstractList .
|
LongObjectProcedure |
Interface that represents a procedure object: a procedure that takes
two arguments and does not return a value.
|
LongProcedure |
Interface that represents a procedure object: a procedure that takes
a single argument and does not return a value.
|
LUDecomposition |
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.
|
LUDecompositionQuick |
A low level version of LUDecomposition , avoiding unnecessary memory allocation and copying.
|
Matrix2DMatrix2DFunction |
Interface that represents a function object: a function that takes
two arguments and returns a single value.
|
MersenneTwister |
MersenneTwister (MT19937) is one of the strongest uniform pseudo-random number generators known so far; at the same time it is quick.
|
MersenneTwister64 |
Same as MersenneTwister except that method raw() returns 64 bit random numbers instead of 32 bit random numbers.
|
MightyStaticBin1D |
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.
|
MinMaxNumberList |
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.
|
Misc |
Not yet commented.
|
Mult |
Only for performance tuning of compute intensive linear algebraic computations.
|
NegativeBinomial |
|
Normal |
|
NormInfinityTest |
|
NumericalIntegration |
Not yet commented.
|
ObjectArrayList |
Resizable list holding Object elements; implemented with arrays.
|
ObjectBuffer |
Fixed sized (non resizable) streaming buffer connected to a target ObjectBufferConsumer to which data is automatically flushed upon buffer overflow.
|
ObjectBufferConsumer |
Target of a streaming ObjectBuffer into which data is flushed upon buffer overflow.
|
ObjectFactory1D |
Factory for convenient construction of 1-d matrices holding Object cells.
|
ObjectFactory2D |
Factory for convenient construction of 2-d matrices holding Object
cells.
|
ObjectFactory3D |
Factory for convenient construction of 3-d matrices holding Object cells.
|
ObjectFunction |
Interface that represents a function object: a function that takes
a single argument and returns a single value.
|
ObjectListAdapter |
Adapter that permits an ObjectArrayList to be viewed and treated as a JDK 1.2 AbstractList .
|
ObjectMatrix1D |
Abstract base class for 1-d matrices (aka vectors) holding Object elements.
|
ObjectMatrix1DComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
ObjectMatrix1DProcedure |
Interface that represents a condition or procedure object: takes
a single argument and returns a boolean value.
|
ObjectMatrix2D |
Abstract base class for 2-d matrices holding Object elements.
|
ObjectMatrix2DComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
ObjectMatrix2DProcedure |
Interface that represents a condition or procedure object: takes
a single argument and returns a boolean value.
|
ObjectMatrix3D |
Abstract base class for 3-d matrices holding Object elements.
|
ObjectMatrix3DProcedure |
Interface that represents a condition or procedure object: takes
a single argument and returns a boolean value.
|
ObjectObjectFunction |
Interface that represents a function object: a function that takes
two arguments and returns a single value.
|
ObjectProcedure |
Interface that represents a procedure object: a procedure that takes
a single argument and does not return a value.
|
OpenDoubleIntHashMap |
Hash map holding (key,value) associations of type (double-->int); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
|
OpenIntDoubleHashMap |
Hash map holding (key,value) associations of type (int-->double); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
|
OpenIntIntHashMap |
Hash map holding (key,value) associations of type (int-->int); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
|
OpenIntObjectHashMap |
Hash map holding (key,value) associations of type (int-->Object); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
|
OpenLongObjectHashMap |
Hash map holding (key,value) associations of type (long-->Object); Automatically grows and shrinks as needed; Implemented using open addressing with double hashing.
|
Partitioning |
Given some interval boundaries, partitions matrices such that cell values falling into an interval are placed next to each other.
|
Partitioning |
Given some interval boundaries, partitions matrices such that cell values falling into an interval are placed next to each other.
|
Partitioning |
Given some interval boundaries, partitions arrays such that all elements falling into an interval are placed next to each other.
|
PersistentObject |
This empty class is the common root for all persistent capable classes.
|
PhysicalConstants |
High Energy Physics coherent Physical Constants.
|
PlusMult |
Only for performance tuning of compute intensive linear algebraic computations.
|
Poisson |
|
PoissonSlow |
|
Polynomial |
Polynomial functions.
|
PrimeFinder |
Not of interest for users; only for implementors of hashtables.
|
Probability |
Custom tailored numerical integration of certain probability distributions.
|
Property |
Tests matrices for linear algebraic properties (equality, tridiagonality, symmetry, singularity, etc).
|
QRDecomposition |
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.
|
QRTest |
|
Quantile1Test |
A class to test the QuantileBin1D code.
|
QuantileBin1D |
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.
|
QuantileCalc |
Computes b and k vor various parameters.
|
QuantileFinderFactory |
Factory constructing exact and approximate quantile finders for both known and unknown N.
|
QuantileFinderTest |
A class holding test cases for exact and approximate quantile finders.
|
QuickBitVector |
Implements quick non polymorphic non bounds checking low level bitvector operations.
|
QuickOpenIntIntHashMap |
Status: Experimental; Do not use for production yet.
|
RandomEngine |
Abstract base class for uniform pseudo-random number generating engines.
|
RandomGenerator |
Interface for uniform pseudo-random number generators.
|
RandomSampler |
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).
|
RandomSamplingAssistant |
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).
|
RandomSeedGenerator |
Deterministic seed generator for pseudo-random number generators.
|
RandomSeedTable |
(Seemingly gigantic) table of good seeds for pseudo-random number generators.
|
RCDoubleMatrix2D |
Sparse row-compressed 2-d matrix holding double elements.
|
RCMDoubleMatrix2D |
Sparse row-compressed-modified 2-d matrix holding double elements.
|
SelectedDenseDoubleMatrix1D |
Selection view on dense 1-d matrices holding double elements.
|
SelectedDenseDoubleMatrix2D |
Selection view on dense 2-d matrices holding double elements.
|
SelectedDenseDoubleMatrix3D |
Selection view on dense 3-d matrices holding double elements.
|
SelectedDenseObjectMatrix1D |
Selection view on dense 1-d matrices holding Object elements.
|
SelectedDenseObjectMatrix2D |
Selection view on dense 2-d matrices holding Object elements.
|
SelectedDenseObjectMatrix3D |
Selection view on dense 3-d matrices holding Object elements.
|
SelectedSparseDoubleMatrix1D |
Selection view on sparse 1-d matrices holding double elements.
|
SelectedSparseDoubleMatrix2D |
Selection view on sparse 2-d matrices holding double elements.
|
SelectedSparseDoubleMatrix3D |
Selection view on sparse 3-d matrices holding double elements.
|
SelectedSparseObjectMatrix1D |
Selection view on sparse 1-d matrices holding Object elements.
|
SelectedSparseObjectMatrix2D |
Selection view on sparse 2-d matrices holding Object elements.
|
SelectedSparseObjectMatrix3D |
Selection view on sparse 3-d matrices holding Object elements.
|
SeqBlas |
Sequential implementation of the Basic Linear Algebra System.
|
ShortArrayList |
Resizable list holding short elements; implemented with arrays.
|
ShortComparator |
A comparison function which imposes a total ordering on some
collection of elements.
|
ShortProcedure |
Interface that represents a procedure object: a procedure that takes
a single argument and does not return a value.
|
SimpleLongArrayList |
Resizable list holding long elements; implemented with arrays; not efficient; just to demonstrate which methods you must override to implement a fully functional list.
|
SingularValueDecomposition |
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'.
|
Smp |
|
SmpBlas |
Parallel implementation of the Basic Linear Algebra System for symmetric multi processing boxes.
|
Sorting |
Matrix quicksorts and mergesorts.
|
Sorting |
Matrix quicksorts and mergesorts.
|
Sorting |
Quicksorts, mergesorts and binary searches; complements java.util.Arrays.
|
SparseDoubleMatrix1D |
Sparse hashed 1-d matrix (aka vector) holding double elements.
|
SparseDoubleMatrix2D |
Sparse hashed 2-d matrix holding double elements.
|
SparseDoubleMatrix3D |
Sparse hashed 3-d matrix holding double elements.
|
SparseObjectMatrix1D |
Sparse hashed 1-d matrix (aka vector) holding Object elements.
|
SparseObjectMatrix2D |
Sparse hashed 2-d matrix holding Object elements.
|
SparseObjectMatrix3D |
Sparse hashed 3-d matrix holding Object elements.
|
Stack |
Not yet commented.
|
StaticBin1D |
1-dimensional non-rebinnable bin consuming double elements;
Efficiently computes basic statistics of data sequences.
|
Statistic |
Basic statistics operations on matrices.
|
Statistic.VectorVectorFunction |
Interface that represents a function object: a function that takes
two argument vectors and returns a single value.
|
Stencil |
Stencil operations.
|
StudentT |
|
Swapper |
Interface for an object that knows how to swap elements at two positions (a,b).
|
Test |
A very(!) basic test of the reference implementations of AIDA histograms.
|
Test2 |
A very(!) basic test of the reference implementations
of AIDA histograms
|
TestMatrix2D |
Quick and dirty tests.
|
Timer |
A handy stopwatch for benchmarking.
|
TimerProcedure |
Interface that represents a procedure object: a procedure that takes
a single argument and does not return a value.
|
Transform |
Deprecated. |
TridiagonalDoubleMatrix2D |
Tridiagonal 2-d matrix holding double elements.
|
Uniform |
|
Units |
High Energy Physics coherent system of Units.
|
UnknownDoubleQuantileEstimator |
Approximate quantile finding algorithm for unknown N requiring only one pass and little main memory; computes quantiles over a sequence of double elements.
|
Util |
Convenient histogram utilities.
|
Utils |
Holds some utility methods shared by different quantile finding implementations.
|
VariableAxis |
Variable-width axis; A reference implementation of hep.aida.IAxis.
|
Version |
Information about the current release.
|
VonMises |
Von Mises distribution.
|
WeightedRandomSampler |
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.
|
WrapperDoubleMatrix1D |
1-d matrix holding double elements; either a view wrapping another matrix or a matrix whose views are wrappers.
|
WrapperDoubleMatrix2D |
2-d matrix holding double elements; either a view wrapping another matrix or a matrix whose views are wrappers.
|
Zeta |
Zeta distribution.
|