Colt 1.0.2

Serialized Form


Package cern.colt

Class cern.colt.PersistentObject implements Serializable

Class cern.colt.Timer implements Serializable

Serialized Fields

baseTime

long baseTime

elapsedTime

long elapsedTime


Package cern.colt.bitvector

Class cern.colt.bitvector.BitMatrix implements Serializable

Serialized Fields

columns

int columns

rows

int rows

bits

long[] bits

Class cern.colt.bitvector.BitVector implements Serializable

Serialized Fields

bits

long[] bits
The bits of this object. The ith bit is stored in bits[i/64] at bit position i % 64 (where bit position 0 refers to the least significant bit and 63 refers to the most significant bit).
 

nbits

int nbits


Package cern.colt.buffer

Class cern.colt.buffer.DoubleBuffer implements Serializable

Serialized Fields

target

DoubleBufferConsumer target

elements

double[] elements

list

DoubleArrayList list

capacity

int capacity

size

int size

Class cern.colt.buffer.DoubleBuffer2D implements Serializable

Serialized Fields

target

DoubleBuffer2DConsumer target

xElements

double[] xElements

yElements

double[] yElements

xList

DoubleArrayList xList

yList

DoubleArrayList yList

capacity

int capacity

size

int size

Class cern.colt.buffer.DoubleBuffer3D implements Serializable

Serialized Fields

target

DoubleBuffer3DConsumer target

xElements

double[] xElements

yElements

double[] yElements

zElements

double[] zElements

xList

DoubleArrayList xList

yList

DoubleArrayList yList

zList

DoubleArrayList zList

capacity

int capacity

size

int size

Class cern.colt.buffer.IntBuffer implements Serializable

Serialized Fields

target

IntBufferConsumer target

elements

int[] elements

list

IntArrayList list

capacity

int capacity

size

int size

Class cern.colt.buffer.IntBuffer2D implements Serializable

Serialized Fields

target

IntBuffer2DConsumer target

xElements

int[] xElements

yElements

int[] yElements

xList

IntArrayList xList

yList

IntArrayList yList

capacity

int capacity

size

int size

Class cern.colt.buffer.IntBuffer3D implements Serializable

Serialized Fields

target

IntBuffer3DConsumer target

xElements

int[] xElements

yElements

int[] yElements

zElements

int[] zElements

xList

IntArrayList xList

yList

IntArrayList yList

zList

IntArrayList zList

capacity

int capacity

size

int size

Class cern.colt.buffer.ObjectBuffer implements Serializable

Serialized Fields

target

ObjectBufferConsumer target

elements

Object[] elements

list

ObjectArrayList list

capacity

int capacity

size

int size


Package cern.colt.list

Class cern.colt.list.AbstractBooleanList implements Serializable

Serialized Fields

size

int size
The size of the list. This is a READ_ONLY variable for all methods but setSizeRaw(int newSize) !!! If you violate this principle in subclasses, you should exactly know what you are doing.
 

Class cern.colt.list.AbstractByteList implements Serializable

Serialized Fields

size

int size
The size of the list. This is a READ_ONLY variable for all methods but setSizeRaw(int newSize) !!! If you violate this principle in subclasses, you should exactly know what you are doing.
 

Class cern.colt.list.AbstractCharList implements Serializable

Serialized Fields

size

int size
The size of the list. This is a READ_ONLY variable for all methods but setSizeRaw(int newSize) !!! If you violate this principle in subclasses, you should exactly know what you are doing.
 

Class cern.colt.list.AbstractCollection implements Serializable

Class cern.colt.list.AbstractDoubleList implements Serializable

Serialized Fields

size

int size
The size of the list. This is a READ_ONLY variable for all methods but setSizeRaw(int newSize) !!! If you violate this principle in subclasses, you should exactly know what you are doing.
 

Class cern.colt.list.AbstractFloatList implements Serializable

Serialized Fields

size

int size
The size of the list. This is a READ_ONLY variable for all methods but setSizeRaw(int newSize) !!! If you violate this principle in subclasses, you should exactly know what you are doing.
 

Class cern.colt.list.AbstractIntList implements Serializable

Serialized Fields

size

int size
The size of the list. This is a READ_ONLY variable for all methods but setSizeRaw(int newSize) !!! If you violate this principle in subclasses, you should exactly know what you are doing.
 

Class cern.colt.list.AbstractList implements Serializable

Class cern.colt.list.AbstractLongList implements Serializable

Serialized Fields

size

int size
The size of the list. This is a READ_ONLY variable for all methods but setSizeRaw(int newSize) !!! If you violate this principle in subclasses, you should exactly know what you are doing.
 

Class cern.colt.list.AbstractShortList implements Serializable

Serialized Fields

size

int size
The size of the list. This is a READ_ONLY variable for all methods but setSizeRaw(int newSize) !!! If you violate this principle in subclasses, you should exactly know what you are doing.
 

Class cern.colt.list.BooleanArrayList implements Serializable

Serialized Fields

elements

boolean[] elements
The array buffer into which the elements of the list are stored. The capacity of the list is the length of this array buffer.
 

Class cern.colt.list.ByteArrayList implements Serializable

Serialized Fields

elements

byte[] elements
The array buffer into which the elements of the list are stored. The capacity of the list is the length of this array buffer.
 

Class cern.colt.list.CharArrayList implements Serializable

Serialized Fields

elements

char[] elements
The array buffer into which the elements of the list are stored. The capacity of the list is the length of this array buffer.
 

Class cern.colt.list.DistinctNumberList implements Serializable

Serialized Fields

distinctValues

long[] distinctValues

elements

MinMaxNumberList elements

Class cern.colt.list.DoubleArrayList implements Serializable

Serialized Fields

elements

double[] elements
The array buffer into which the elements of the list are stored. The capacity of the list is the length of this array buffer.
 

Class cern.colt.list.FloatArrayList implements Serializable

Serialized Fields

elements

float[] elements
The array buffer into which the elements of the list are stored. The capacity of the list is the length of this array buffer.
 

Class cern.colt.list.IntArrayList implements Serializable

Serialized Fields

elements

int[] elements
The array buffer into which the elements of the list are stored. The capacity of the list is the length of this array buffer.
 

Class cern.colt.list.LongArrayList implements Serializable

Serialized Fields

elements

long[] elements
The array buffer into which the elements of the list are stored. The capacity of the list is the length of this array buffer.
 

Class cern.colt.list.MinMaxNumberList implements Serializable

Serialized Fields

minValue

long minValue

bitsPerElement

int bitsPerElement

bits

long[] bits

capacity

int capacity

Class cern.colt.list.ObjectArrayList implements Serializable

Serialized Fields

elements

Object[] elements
The array buffer into which the elements of the list are stored. The capacity of the list is the length of this array buffer.
 

size

int size
The size of the list.
 

Class cern.colt.list.ShortArrayList implements Serializable

Serialized Fields

elements

short[] elements
The array buffer into which the elements of the list are stored. The capacity of the list is the length of this array buffer.
 

Class cern.colt.list.SimpleLongArrayList implements Serializable

Serialized Fields

elements

long[] elements
The array buffer into which the elements of the list are stored. The capacity of the list is the length of this array buffer.
 

size

int size
The size of the list.
 


Package cern.colt.map

Class cern.colt.map.AbstractDoubleIntMap implements Serializable

Class cern.colt.map.AbstractIntDoubleMap implements Serializable

Class cern.colt.map.AbstractIntIntMap implements Serializable

Class cern.colt.map.AbstractIntObjectMap implements Serializable

Class cern.colt.map.AbstractLongObjectMap implements Serializable

Class cern.colt.map.AbstractMap implements Serializable

Serialized Fields

distinct

int distinct
The number of distinct associations in the map; its "size()".

lowWaterMark

int lowWaterMark
The table capacity c=table.length always satisfies the invariant c * minLoadFactor <= s <= c * maxLoadFactor, where s=size() is the number of associations currently contained. The term "c * minLoadFactor" is called the "lowWaterMark", "c * maxLoadFactor" is called the "highWaterMark". In other words, the table capacity (and proportionally the memory used by this class) oscillates within these constraints. The terms are precomputed and cached to avoid recalculating them each time put(..) or removeKey(...) is called.

highWaterMark

int highWaterMark

minLoadFactor

double minLoadFactor
The minimum load factor for the hashtable.

maxLoadFactor

double maxLoadFactor
The maximum load factor for the hashtable.

Class cern.colt.map.OpenDoubleIntHashMap implements Serializable

Serialized Fields

table

double[] table
The hash table keys.
 

values

int[] values
The hash table values.
 

state

byte[] state
The state of each hash table entry (FREE, FULL, REMOVED).
 

freeEntries

int freeEntries
The number of table entries in state==FREE.
 

Class cern.colt.map.OpenIntDoubleHashMap implements Serializable

Serialized Fields

table

int[] table
The hash table keys.
 

values

double[] values
The hash table values.
 

state

byte[] state
The state of each hash table entry (FREE, FULL, REMOVED).
 

freeEntries

int freeEntries
The number of table entries in state==FREE.
 

Class cern.colt.map.OpenIntIntHashMap implements Serializable

Serialized Fields

table

int[] table
The hash table keys.
 

values

int[] values
The hash table values.
 

state

byte[] state
The state of each hash table entry (FREE, FULL, REMOVED).
 

freeEntries

int freeEntries
The number of table entries in state==FREE.
 

Class cern.colt.map.OpenIntObjectHashMap implements Serializable

Serialized Fields

table

int[] table
The hash table keys.
 

values

Object[] values
The hash table values.
 

state

byte[] state
The state of each hash table entry (FREE, FULL, REMOVED).
 

freeEntries

int freeEntries
The number of table entries in state==FREE.
 

Class cern.colt.map.OpenLongObjectHashMap implements Serializable

Serialized Fields

table

long[] table
The hash table keys.
 

values

Object[] values
The hash table values.
 

state

byte[] state
The state of each hash table entry (FREE, FULL, REMOVED).
 

freeEntries

int freeEntries
The number of table entries in state==FREE.
 


Package cern.colt.matrix

Class cern.colt.matrix.DoubleFactory1D implements Serializable

Class cern.colt.matrix.DoubleFactory2D implements Serializable

Class cern.colt.matrix.DoubleFactory3D implements Serializable

Class cern.colt.matrix.DoubleMatrix1D implements Serializable

Class cern.colt.matrix.DoubleMatrix2D implements Serializable

Class cern.colt.matrix.DoubleMatrix3D implements Serializable

Class cern.colt.matrix.ObjectFactory1D implements Serializable

Class cern.colt.matrix.ObjectFactory2D implements Serializable

Class cern.colt.matrix.ObjectFactory3D implements Serializable

Class cern.colt.matrix.ObjectMatrix1D implements Serializable

Class cern.colt.matrix.ObjectMatrix2D implements Serializable

Class cern.colt.matrix.ObjectMatrix3D implements Serializable


Package cern.colt.matrix.doublealgo

Class cern.colt.matrix.doublealgo.Formatter implements Serializable

Class cern.colt.matrix.doublealgo.Sorting implements Serializable

Class cern.colt.matrix.doublealgo.Transform implements Serializable


Package cern.colt.matrix.impl

Class cern.colt.matrix.impl.AbstractFormatter implements Serializable

Serialized Fields

alignment

String alignment
The default format string for formatting a single cell value; currently "%G".

format

String format
The default format string for formatting a single cell value; currently "%G".

minColumnWidth

int minColumnWidth
The default minimum number of characters a column may have; currently 1.

columnSeparator

String columnSeparator
The default string separating any two columns from another; currently " ".

rowSeparator

String rowSeparator
The default string separating any two rows from another; currently "\n".

sliceSeparator

String sliceSeparator
The default string separating any two slices from another; currently "\n\n".

printShape

boolean printShape
Tells whether String representations are to be preceded with summary of the shape; currently true.

Class cern.colt.matrix.impl.AbstractMatrix implements Serializable

Serialized Fields

isNoView

boolean isNoView

Class cern.colt.matrix.impl.AbstractMatrix1D implements Serializable

Serialized Fields

size

int size
the number of cells this matrix (view) has

zero

int zero
the index of the first element

stride

int stride
the number of indexes between any two elements, i.e. index(i+1) - index(i).

Class cern.colt.matrix.impl.AbstractMatrix2D implements Serializable

Serialized Fields

columns

int columns
the number of colums and rows this matrix (view) has

rows

int rows
the number of colums and rows this matrix (view) has

rowStride

int rowStride
the number of elements between two rows, i.e. index(i+1,j,k) - index(i,j,k).

columnStride

int columnStride
the number of elements between two columns, i.e. index(i,j+1,k) - index(i,j,k).

rowZero

int rowZero
the index of the first element

columnZero

int columnZero
the index of the first element

Class cern.colt.matrix.impl.AbstractMatrix3D implements Serializable

Serialized Fields

slices

int slices
the number of slices this matrix (view) has

rows

int rows
the number of rows this matrix (view) has

columns

int columns
the number of columns this matrix (view) has

sliceStride

int sliceStride
the number of elements between two slices, i.e. index(k+1,i,j) - index(k,i,j).

rowStride

int rowStride
the number of elements between two rows, i.e. index(k,i+1,j) - index(k,i,j).

columnStride

int columnStride
the number of elements between two columns, i.e. index(k,i,j+1) - index(k,i,j).

sliceZero

int sliceZero
the index of the first element

rowZero

int rowZero
the index of the first element

columnZero

int columnZero
the index of the first element

Class cern.colt.matrix.impl.DenseDoubleMatrix1D implements Serializable

Serialized Fields

elements

double[] elements
The elements of this matrix.

Class cern.colt.matrix.impl.DenseDoubleMatrix2D implements Serializable

Serialized Fields

elements

double[] elements
The elements of this matrix. elements are stored in row major, i.e. index==row*columns + column columnOf(index)==index%columns rowOf(index)==index/columns i.e. {row0 column0..m}, {row1 column0..m}, ..., {rown column0..m}

Class cern.colt.matrix.impl.DenseDoubleMatrix3D implements Serializable

Serialized Fields

elements

double[] elements
The elements of this matrix. elements are stored in slice major, then row major, then column major, in order of significance, i.e. index==slice*sliceStride+ row*rowStride + column*columnStride i.e. {slice0 row0..m}, {slice1 row0..m}, ..., {sliceN row0..m} with each row storead as {row0 column0..m}, {row1 column0..m}, ..., {rown column0..m}

Class cern.colt.matrix.impl.DenseObjectMatrix1D implements Serializable

Serialized Fields

elements

Object[] elements
The elements of this matrix.

Class cern.colt.matrix.impl.DenseObjectMatrix2D implements Serializable

Serialized Fields

elements

Object[] elements
The elements of this matrix. elements are stored in row major, i.e. index==row*columns + column columnOf(index)==index%columns rowOf(index)==index/columns i.e. {row0 column0..m}, {row1 column0..m}, ..., {rown column0..m}

Class cern.colt.matrix.impl.DenseObjectMatrix3D implements Serializable

Serialized Fields

elements

Object[] elements
The elements of this matrix. elements are stored in slice major, then row major, then column major, in order of significance, i.e. index==slice*sliceStride+ row*rowStride + column*columnStride i.e. {slice0 row0..m}, {slice1 row0..m}, ..., {sliceN row0..m} with each row storead as {row0 column0..m}, {row1 column0..m}, ..., {rown column0..m}

Class cern.colt.matrix.impl.RCDoubleMatrix2D implements Serializable

Serialized Fields

indexes

IntArrayList indexes

values

DoubleArrayList values

starts

int[] starts

Class cern.colt.matrix.impl.SparseDoubleMatrix1D implements Serializable

Serialized Fields

elements

AbstractIntDoubleMap elements

Class cern.colt.matrix.impl.SparseDoubleMatrix2D implements Serializable

Serialized Fields

elements

AbstractIntDoubleMap elements

dummy

int dummy

Class cern.colt.matrix.impl.SparseDoubleMatrix3D implements Serializable

Serialized Fields

elements

AbstractIntDoubleMap elements

Class cern.colt.matrix.impl.SparseObjectMatrix1D implements Serializable

Serialized Fields

elements

AbstractIntObjectMap elements

Class cern.colt.matrix.impl.SparseObjectMatrix2D implements Serializable

Serialized Fields

elements

AbstractIntObjectMap elements

Class cern.colt.matrix.impl.SparseObjectMatrix3D implements Serializable

Serialized Fields

elements

AbstractIntObjectMap elements


Package cern.colt.matrix.linalg

Class cern.colt.matrix.linalg.Algebra implements Serializable

Serialized Fields

property

Property property
The property object attached to this instance.

Class cern.colt.matrix.linalg.CholeskyDecomposition implements Serializable

Serialized Fields

L

DoubleMatrix2D L
Array for internal storage of decomposition.
internal array storage.

n

int n
Row and column dimension (square matrix).
matrix dimension.

isSymmetricPositiveDefinite

boolean isSymmetricPositiveDefinite
Symmetric and positive definite flag.
is symmetric and positive definite flag.

Class cern.colt.matrix.linalg.EigenvalueDecomposition implements Serializable

Serialized Fields

n

int n
Row and column dimension (square matrix).
matrix dimension.

issymmetric

boolean issymmetric
Symmetry flag.
internal symmetry flag.

d

double[] d
Arrays for internal storage of eigenvalues.
internal storage of eigenvalues.

e

double[] e
Arrays for internal storage of eigenvalues.
internal storage of eigenvalues.

V

double[][] V
Array for internal storage of eigenvectors.
internal storage of eigenvectors.

H

double[][] H
Array for internal storage of nonsymmetric Hessenberg form.
internal storage of nonsymmetric Hessenberg form.

ort

double[] ort
Working storage for nonsymmetric algorithm.
working storage for nonsymmetric algorithm.

Class cern.colt.matrix.linalg.LUDecomposition implements Serializable

Serialized Fields

quick

LUDecompositionQuick quick

Class cern.colt.matrix.linalg.LUDecompositionQuick implements Serializable

Serialized Fields

LU

DoubleMatrix2D LU
Array for internal storage of decomposition.
internal array storage.

pivsign

int pivsign
pivot sign.
pivot sign.

piv

int[] piv
Internal storage of pivot vector.
pivot vector.

isNonSingular

boolean isNonSingular

algebra

Algebra algebra

Class cern.colt.matrix.linalg.Property implements Serializable

Serialized Fields

tolerance

double tolerance

Class cern.colt.matrix.linalg.QRDecomposition implements Serializable

Serialized Fields

QR

DoubleMatrix2D QR
Array for internal storage of decomposition.
internal array storage.

m

int m
Row and column dimensions.
column dimension.

n

int n
Row and column dimensions.
column dimension.

Rdiag

DoubleMatrix1D Rdiag
Array for internal storage of diagonal of R.
diagonal of R.

Class cern.colt.matrix.linalg.SingularValueDecomposition implements Serializable

Serialized Fields

U

double[][] U
Arrays for internal storage of U and V.
internal storage of U.

V

double[][] V
Arrays for internal storage of U and V.
internal storage of U.

s

double[] s
Array for internal storage of singular values.
internal storage of singular values.

m

int m
Row and column dimensions.
row dimension.

n

int n
Row and column dimensions.
row dimension.


Package cern.colt.matrix.objectalgo

Class cern.colt.matrix.objectalgo.Formatter implements Serializable

Class cern.colt.matrix.objectalgo.Sorting implements Serializable


Package cern.jet.random

Class cern.jet.random.AbstractContinousDistribution implements Serializable

Class cern.jet.random.AbstractDiscreteDistribution implements Serializable

Class cern.jet.random.AbstractDistribution implements Serializable

Serialized Fields

randomGenerator

RandomElement randomGenerator

Class cern.jet.random.Benchmark implements Serializable

Serialized Fields

randomGenerator

RandomElement randomGenerator

Class cern.jet.random.Beta implements Serializable

Serialized Fields

alpha

double alpha

beta

double beta

PDF_CONST

double PDF_CONST

a_last

double a_last

b_last

double b_last

a_

double a_

b_

double b_

t

double t

fa

double fa

fb

double fb

p1

double p1

p2

double p2

c

double c

ml

double ml

mu

double mu

p_last

double p_last

q_last

double q_last

a

double a

b

double b

s

double s

m

double m

D

double D

Dl

double Dl

x1

double x1

x2

double x2

x4

double x4

x5

double x5

f1

double f1

f2

double f2

f4

double f4

f5

double f5

ll

double ll

lr

double lr

z2

double z2

z4

double z4

p3

double p3

p4

double p4

Class cern.jet.random.Binomial implements Serializable

Serialized Fields

n

int n

p

double p

n_last

int n_last

n_prev

int n_prev

par

double par

np

double np

p0

double p0

q

double q

p_last

double p_last

p_prev

double p_prev

b

int b

m

int m

nm

int nm

pq

double pq

rc

double rc

ss

double ss

xm

double xm

xl

double xl

xr

double xr

ll

double ll

lr

double lr

c

double c

p1

double p1

p2

double p2

p3

double p3

p4

double p4

ch

double ch

log_p

double log_p

log_q

double log_q

log_n

double log_n

Class cern.jet.random.BreitWigner implements Serializable

Serialized Fields

mean

double mean

gamma

double gamma

cut

double cut

Class cern.jet.random.BreitWignerMeanSquare implements Serializable

Serialized Fields

uniform

Uniform uniform

Class cern.jet.random.ChiSquare implements Serializable

Serialized Fields

freedom

double freedom

freedom_in

double freedom_in

b

double b

vm

double vm

vp

double vp

vd

double vd

Class cern.jet.random.Empirical implements Serializable

Serialized Fields

cdf

double[] cdf

interpolationType

int interpolationType

Class cern.jet.random.EmpiricalWalker implements Serializable

Serialized Fields

K

int K

A

int[] A

F

double[] F

cdf

double[] cdf

Class cern.jet.random.Exponential implements Serializable

Serialized Fields

lambda

double lambda

Class cern.jet.random.ExponentialPower implements Serializable

Serialized Fields

tau

double tau

s

double s

sm1

double sm1

tau_set

double tau_set

Class cern.jet.random.Gamma implements Serializable

Serialized Fields

alpha

double alpha

lambda

double lambda

Class cern.jet.random.Hyperbolic implements Serializable

Serialized Fields

alpha

double alpha

beta

double beta

a_setup

double a_setup

b_setup

double b_setup

x

double x

u

double u

v

double v

e

double e

hr

double hr

hl

double hl

s

double s

pm

double pm

pr

double pr

samb

double samb

pmr

double pmr

mpa_1

double mpa_1

mmb_1

double mmb_1

Class cern.jet.random.HyperGeometric implements Serializable

Serialized Fields

my_N

int my_N

my_s

int my_s

my_n

int my_n

N_last

int N_last

M_last

int M_last

n_last

int n_last

N_Mn

int N_Mn

m

int m

mp

int mp

b

int b

Mp

double Mp

np

double np

fm

double fm

k2

int k2

k4

int k4

k1

int k1

k5

int k5

dl

double dl

dr

double dr

r1

double r1

r2

double r2

r4

double r4

r5

double r5

ll

double ll

lr

double lr

c_pm

double c_pm

f1

double f1

f2

double f2

f4

double f4

f5

double f5

p1

double p1

p2

double p2

p3

double p3

p4

double p4

p5

double p5

p6

double p6

Class cern.jet.random.Logarithmic implements Serializable

Serialized Fields

my_p

double my_p

t

double t

h

double h

a_prev

double a_prev

Class cern.jet.random.NegativeBinomial implements Serializable

Serialized Fields

n

int n

p

double p

gamma

Gamma gamma

poisson

Poisson poisson

Class cern.jet.random.Normal implements Serializable

Serialized Fields

mean

double mean

variance

double variance

standardDeviation

double standardDeviation

cache

double cache

cacheFilled

boolean cacheFilled

SQRT_INV

double SQRT_INV

Class cern.jet.random.Poisson implements Serializable

Serialized Fields

mean

double mean

my_old

double my_old

p

double p

q

double q

p0

double p0

pp

double[] pp

llll

int llll

my_last

double my_last

ll

double ll

k2

int k2

k4

int k4

k1

int k1

k5

int k5

dl

double dl

dr

double dr

r1

double r1

r2

double r2

r4

double r4

r5

double r5

lr

double lr

l_my

double l_my

c_pm

double c_pm

f1

double f1

f2

double f2

f4

double f4

f5

double f5

p1

double p1

p2

double p2

p3

double p3

p4

double p4

p5

double p5

p6

double p6

m

int m

Class cern.jet.random.PoissonSlow implements Serializable

Serialized Fields

mean

double mean

cached_sq

double cached_sq

cached_alxm

double cached_alxm

cached_g

double cached_g

Class cern.jet.random.StudentT implements Serializable

Serialized Fields

freedom

double freedom

TERM

double TERM

Class cern.jet.random.Uniform implements Serializable

Serialized Fields

min

double min

max

double max

Class cern.jet.random.VonMises implements Serializable

Serialized Fields

my_k

double my_k

k_set

double k_set

tau

double tau

rho

double rho

r

double r

Class cern.jet.random.Zeta implements Serializable

Serialized Fields

ro

double ro

pk

double pk

c

double c

d

double d

ro_prev

double ro_prev

pk_prev

double pk_prev

maxlongint

double maxlongint


Package cern.jet.random.engine

Class cern.jet.random.engine.DRand implements Serializable

Serialized Fields

current

int current

Class cern.jet.random.engine.MersenneTwister implements Serializable

Serialized Fields

mti

int mti

mt

int[] mt

Class cern.jet.random.engine.MersenneTwister64 implements Serializable

Class cern.jet.random.engine.RandomEngine implements Serializable

Class cern.jet.random.engine.RandomSeedGenerator implements Serializable

Serialized Fields

row

int row

column

int column


Package cern.jet.random.sampling

Class cern.jet.random.sampling.RandomSampler implements Serializable

Serialized Fields

my_n

long my_n

my_N

long my_N

my_low

long my_low

my_RandomGenerator

RandomElement my_RandomGenerator

Class cern.jet.random.sampling.RandomSamplingAssistant implements Serializable

Serialized Fields

sampler

RandomSampler sampler

buffer

long[] buffer

bufferPosition

int bufferPosition

skip

long skip

n

long n

Class cern.jet.random.sampling.WeightedRandomSampler implements Serializable

Serialized Fields

skip

int skip

nextTriggerPos

int nextTriggerPos

nextSkip

int nextSkip

weight

int weight

generator

Uniform generator


Package cern.jet.stat.quantile

Class cern.jet.stat.quantile.EquiDepthHistogram implements Serializable

Serialized Fields

binBoundaries

float[] binBoundaries


Package com.imsl.math

Class com.imsl.math.Complex implements Serializable

Serialized Fields

re

double re
Real part of the Complex.

im

double im
Imaginary part of the Complex.


Package corejava

Class corejava.Format implements Serializable

Serialized Fields

width

int width

precision

int precision

pre

String pre

post

String post

leading_zeroes

boolean leading_zeroes

show_plus

boolean show_plus

alternate

boolean alternate

show_space

boolean show_space

left_align

boolean left_align

fmt

char fmt


Package edu.cornell.lassp.houle.RngPack

Class edu.cornell.lassp.houle.RngPack.RandomElement implements Serializable

Serialized Fields

BMoutput

double BMoutput

BMoutputAvailable

boolean BMoutputAvailable

Class edu.cornell.lassp.houle.RngPack.RandomJava implements Serializable

Class edu.cornell.lassp.houle.RngPack.RandomSeedable implements Serializable

Class edu.cornell.lassp.houle.RngPack.RandomShuffle implements Serializable

Serialized Fields

generatorA

RandomElement generatorA

generatorB

RandomElement generatorB

decksize

int decksize

deck

double[] deck

Class edu.cornell.lassp.houle.RngPack.Ranecu implements Serializable

Serialized Fields

iseed1

int iseed1

iseed2

int iseed2

Class edu.cornell.lassp.houle.RngPack.Ranlux implements Serializable

Serialized Fields

iseeds

int[] iseeds

isdext

int[] isdext

next

int[] next

luxlev

int luxlev

nskip

int nskip

inseed

int inseed

jseed

int jseed

in24

int in24

kount

int kount

mkount

int mkount

i24

int i24

j24

int j24

seeds

float[] seeds

carry

float carry

twom24

float twom24

twom12

float twom12

diagOn

boolean diagOn

Class edu.cornell.lassp.houle.RngPack.Ranmar implements Serializable

Serialized Fields

c

double c

cd

double cd

cm

double cm

u

double[] u

uvec

double[] uvec

i97

int i97

j97

int j97


Package edu.oswego.cs.dl.util.concurrent

Class edu.oswego.cs.dl.util.concurrent.BrokenBarrierException implements Serializable

Serialized Fields

index

int index
The index that barrier would have returned upon normal return;

Class edu.oswego.cs.dl.util.concurrent.ConcurrentHashMap implements Serializable

Serialized Fields

segments

edu.oswego.cs.dl.util.concurrent.ConcurrentHashMap.Segment[] segments
The array of concurrency control segments.

loadFactor

float loadFactor
The load factor for the hash table.
 

threshold

int threshold
The table is rehashed when its size exceeds this threshold. (The value of this field is always (int)(capacity * loadFactor).)
 

Class edu.oswego.cs.dl.util.concurrent.ConcurrentReaderHashMap implements Serializable

Serialized Fields

threshold

int threshold
The table is rehashed when its size exceeds this threshold. (The value of this field is always (int)(capacity * loadFactor).)
 

loadFactor

float loadFactor
The load factor for the hash table.
 

Class edu.oswego.cs.dl.util.concurrent.CopyOnWriteArrayList implements Serializable

Class edu.oswego.cs.dl.util.concurrent.CopyOnWriteArraySet implements Serializable

Serialized Fields

al

CopyOnWriteArrayList al

Class edu.oswego.cs.dl.util.concurrent.PropertyChangeMulticaster implements Serializable

Serialization Methods

readObject

private void readObject(ObjectInputStream s)
                 throws ClassNotFoundException,
                        IOException

writeObject

private void writeObject(ObjectOutputStream s)
                  throws IOException
Serial Data:
Null terminated list of PropertyChangeListeners.

At serialization time we skip non-serializable listeners and only serialize the serializable listeners.

Serialized Fields

source

Object source
The object to be provided as the "source" for any generated events.
 

children

HashMap children
HashMap for managing listeners for specific properties. Maps property names to PropertyChangeMulticaster objects.
 

Class edu.oswego.cs.dl.util.concurrent.TimeoutException implements Serializable

Serialized Fields

duration

long duration
The approximate time that the operation lasted before this timeout exception was thrown.

Class edu.oswego.cs.dl.util.concurrent.VetoableChangeMulticaster implements Serializable

Serialization Methods

readObject

private void readObject(ObjectInputStream s)
                 throws ClassNotFoundException,
                        IOException

writeObject

private void writeObject(ObjectOutputStream s)
                  throws IOException
Serial Data:
Null terminated list of VetoableChangeListeners.

At serialization time we skip non-serializable listeners and only serialize the serializable listeners.

Serialized Fields

source

Object source
The object to be provided as the "source" for any generated events.
 

children

HashMap children
HashMap for managing listeners for specific properties. Maps property names to VetoableChangeMulticaster objects.
 


Package edu.oswego.cs.dl.util.concurrent.misc

Class edu.oswego.cs.dl.util.concurrent.misc.Fraction implements Serializable

Serialized Fields

numerator_

long numerator_

denominator_

long denominator_


Package hep.aida.bin

Class hep.aida.bin.AbstractBin implements Serializable

Class hep.aida.bin.AbstractBin1D implements Serializable

Class hep.aida.bin.DynamicBin1D implements Serializable

Serialized Fields

elements

DoubleArrayList elements
The elements contained in this bin.

sortedElements

DoubleArrayList sortedElements
The elements contained in this bin, sorted ascending.

fixedOrder

boolean fixedOrder
Preserve element order under all circumstances?

isSorted

boolean isSorted

isIncrementalStatValid

boolean isIncrementalStatValid

isSumOfInversionsValid

boolean isSumOfInversionsValid

isSumOfLogarithmsValid

boolean isSumOfLogarithmsValid

Class hep.aida.bin.MightyStaticBin1D implements Serializable

Serialized Fields

hasSumOfLogarithms

boolean hasSumOfLogarithms

sumOfLogarithms

double sumOfLogarithms

hasSumOfInversions

boolean hasSumOfInversions

sumOfInversions

double sumOfInversions

sumOfPowers

double[] sumOfPowers

Class hep.aida.bin.QuantileBin1D implements Serializable

Serialized Fields

finder

DoubleQuantileFinder finder

Class hep.aida.bin.StaticBin1D implements Serializable

Serialized Fields

size

int size
The number of elements consumed by incremental parameter maintainance.

min

double min

max

double max

sum

double sum

sum_xx

double sum_xx


Package hep.aida.ref

Class hep.aida.ref.FixedAxis implements Serializable

Serialized Fields

bins

int bins

min

double min

binWidth

double binWidth

xunder

int xunder

xover

int xover

Class hep.aida.ref.Histogram1D implements Serializable

Serialized Fields

errors

double[] errors

heights

double[] heights

entries

int[] entries

nEntry

int nEntry

sumWeight

double sumWeight

sumWeightSquared

double sumWeightSquared

mean

double mean

rms

double rms

Class hep.aida.ref.Histogram2D implements Serializable

Serialized Fields

heights

double[][] heights

errors

double[][] errors

entries

int[][] entries

nEntry

int nEntry

sumWeight

double sumWeight

sumWeightSquared

double sumWeightSquared

meanX

double meanX

rmsX

double rmsX

meanY

double meanY

rmsY

double rmsY

Class hep.aida.ref.Histogram3D implements Serializable

Serialized Fields

heights

double[][][] heights

errors

double[][][] errors

entries

int[][][] entries

nEntry

int nEntry

sumWeight

double sumWeight

sumWeightSquared

double sumWeightSquared

meanX

double meanX

rmsX

double rmsX

meanY

double meanY

rmsY

double rmsY

meanZ

double meanZ

rmsZ

double rmsZ

Class hep.aida.ref.VariableAxis implements Serializable

Serialized Fields

min

double min

bins

int bins

edges

double[] edges


Colt 1.0.2

Submit a bug or feature. Check the Colt home page for the latest news.