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

A

a - Variable in class org.jenetics.util.LCG64ShiftRandom.Param
The parameter a of the LC recursion.
AbstractAlterer<G extends Gene<?,G>> - Class in org.jenetics
Abstract implementation of the alterer interface.
AbstractAlterer(double) - Constructor for class org.jenetics.AbstractAlterer
Constructs an alterer with a given recombination probability.
AbstractChromosome<G extends Gene<?,G>> - Class in org.jenetics
The abstract base implementation of the Chromosome interface.
AbstractChromosome(ISeq<? extends G>) - Constructor for class org.jenetics.AbstractChromosome
Create a new AbstractChromosome from the given genes array.
accumulate(C) - Method in class org.jenetics.stat.Histogram
 
accumulate(N) - Method in class org.jenetics.stat.Mean
 
accumulate(N) - Method in class org.jenetics.stat.Quantile
 
accumulate(N) - Method in class org.jenetics.stat.Variance
 
accumulate(T) - Method in interface org.jenetics.util.Accumulator
Accumulate the given value.
accumulate(Executor, Iterable<? extends T>, Seq<? extends Accumulator<? super T>>) - Static method in class org.jenetics.util.accumulators
Calls the Accumulator.accumulate(Object) method of all given accumulators with each value of the given values.
accumulate(Executor, Iterable<? extends T>, Accumulator<? super T>...) - Static method in class org.jenetics.util.accumulators
Calls the Accumulator.accumulate(Object) method of all given accumulators with each value of the given values.
accumulate(Iterator<? extends T>, Accumulator<? super T>) - Static method in class org.jenetics.util.accumulators
Calls the Accumulator.accumulate(Object) method of the given accumulator with each value of the given values.
accumulate(Iterable<? extends T>, Accumulator<? super T>) - Static method in class org.jenetics.util.accumulators
Calls the Accumulator.accumulate(Object) method of the given accumulator with each value of the given values.
accumulate(Executor, Iterable<? extends T>, Accumulator<? super T>, Accumulator<? super T>) - Static method in class org.jenetics.util.accumulators
Calls the Accumulator.accumulate(Object) method of all given accumulators with each value of the given values.
accumulate(Executor, Iterable<? extends T>, Accumulator<? super T>, Accumulator<? super T>, Accumulator<? super T>) - Static method in class org.jenetics.util.accumulators
Calls the Accumulator.accumulate(Object) method of all given accumulators with each value of the given values.
accumulate(Executor, Iterable<? extends T>, Accumulator<? super T>, Accumulator<? super T>, Accumulator<? super T>, Accumulator<? super T>) - Static method in class org.jenetics.util.accumulators
Calls the Accumulator.accumulate(Object) method of all given accumulators with each value of the given values.
accumulate(Executor, Iterable<? extends T>, Accumulator<? super T>, Accumulator<? super T>, Accumulator<? super T>, Accumulator<? super T>, Accumulator<? super T>) - Static method in class org.jenetics.util.accumulators
Calls the Accumulator.accumulate(Object) method of all given accumulators with each value of the given values.
accumulate(C) - Method in class org.jenetics.util.accumulators.Max
 
accumulate(C) - Method in class org.jenetics.util.accumulators.Min
 
accumulate(C) - Method in class org.jenetics.util.accumulators.MinMax
 
accumulate(T) - Method in class org.jenetics.util.MappedAccumulator
 
Accumulator<T> - Interface in org.jenetics.util
Interface for accumulating values of a given type.
accumulators - Class in org.jenetics.util
Collection of some general purpose Accumulators and some static helper classes for accumulating.
accumulators.Max<C extends Comparable<? super C>> - Class in org.jenetics.util
Calculates max value.
accumulators.Max() - Constructor for class org.jenetics.util.accumulators.Max
Create a new Max accumulator.
accumulators.Max(accumulators.Max<C>) - Constructor for class org.jenetics.util.accumulators.Max
Copy constructor.
accumulators.Min<C extends Comparable<? super C>> - Class in org.jenetics.util
Calculates min value.
accumulators.Min() - Constructor for class org.jenetics.util.accumulators.Min
Create a new Min accumulator.
accumulators.Min(accumulators.Min<C>) - Constructor for class org.jenetics.util.accumulators.Min
Copy constructor.
accumulators.MinMax<C extends Comparable<? super C>> - Class in org.jenetics.util
Calculates min and max values.
accumulators.MinMax() - Constructor for class org.jenetics.util.accumulators.MinMax
Create a new min-max accumulator.
accumulators.MinMax(accumulators.MinMax<C>) - Constructor for class org.jenetics.util.accumulators.MinMax
Copy constructor.
add(Phenotype<G, C>) - Method in class org.jenetics.Population
Add Phenotype to the Population.
add(int, Phenotype<G, C>) - Method in class org.jenetics.Population
Add Phenotype to the Population.
add(T) - Method in class org.jenetics.util.Array
Create a new array which contains the values of this and the given value.
add(Array<? extends T>) - Method in class org.jenetics.util.Array
Create a new array which contains the values of this and the given array.
add(Collection<? extends T>) - Method in class org.jenetics.util.Array
Create a new array which contains the values of this and the given values.
addAll(Collection<? extends Phenotype<G, C>>) - Method in class org.jenetics.Population
 
addAll(int, Collection<? extends Phenotype<G, C>>) - Method in class org.jenetics.Population
 
Age(int) - Static method in class org.jenetics.Phenotype
Create a Function which return the phenotype age when calling converter.convert(phenotype).
ageMean(double) - Method in class org.jenetics.Statistics.Builder
 
ageVariance(double) - Method in class org.jenetics.Statistics.Builder
 
Allele - Static variable in enum org.jenetics.BitGene
Converter for accessing the allele from a given gene.
Allele - Static variable in class org.jenetics.CharacterGene
Converter for accessing the allele from a given gene.
alter(Population<G, C>, int) - Method in interface org.jenetics.Alterer
Alters (recombine) a given population.
alter(Population<G, C>, int) - Method in class org.jenetics.CompositeAlterer
 
alter(Population<G, C>, int) - Method in class org.jenetics.Mutator
Concrete implementation of the alter method.
alter(Population<G, C>, int) - Method in class org.jenetics.Recombinator
 
alter - Variable in class org.jenetics.Statistics.Time
The alter time.
Alterer<G extends Gene<?,G>> - Interface in org.jenetics
The Alterer is responsible for the changing/recombining the Population.
and(Function<? super T, Boolean>, Function<? super T, Boolean>) - Static method in class org.jenetics.util.functions
Return a and combination of the given predicates.
append(Alterer<G>) - Method in class org.jenetics.CompositeAlterer
Create a new CompositeAlterer with the given alterer appended.
apply(Double) - Method in class org.jenetics.ExponentialScaler
 
apply(T) - Method in interface org.jenetics.util.Function
Apply the body of this function to the argument.
Array<T> - Class in org.jenetics.util
Array class which wraps the the java build in array type T[].
Array(int) - Constructor for class org.jenetics.util.Array
Create a new array with the given length.
arrays - Class in org.jenetics.util
Static helper methods concerning arrays.
ascending() - Method in enum org.jenetics.Optimize
Create an appropriate comparator of the given optimization strategy.
asList() - Method in class org.jenetics.util.Array
 
asList() - Method in interface org.jenetics.util.Seq
Returns a fixed-size list backed by the specified sequence.

B

b - Variable in class org.jenetics.util.LCG64ShiftRandom.Param
The parameter b of the LC recursion.
best(C, C) - Method in enum org.jenetics.Optimize
Return the best value, according to this optimization direction.
bestPhenotype(Phenotype<G, C>) - Method in class org.jenetics.Statistics.Builder
 
bit - Class in org.jenetics.util
Some bit utils.
BitChromosome - Class in org.jenetics
Implementation of the classical BitChromosome.
BitChromosome(byte[], int, int) - Constructor for class org.jenetics.BitChromosome
Create a new bit chromosome from the given bit (byte) array.
BitChromosome(byte[]) - Constructor for class org.jenetics.BitChromosome
Create a new BitChromosome from the given byte array.
bitCount() - Method in class org.jenetics.BitChromosome
Returns the number of bits set to true in this BitChromosome.
BitGene - Enum in org.jenetics
Implementation of a BitGene.
BoltzmannSelector<G extends Gene<?,G>,N extends Number & Comparable<? super N>> - Class in org.jenetics
In this Selector, the probability for selection is defined as.
BoltzmannSelector(double) - Constructor for class org.jenetics.BoltzmannSelector
Create a new BoltzmanSelector with the given b value.
BoltzmannSelector() - Constructor for class org.jenetics.BoltzmannSelector
Create a new BoltzmannSelector with a default beta of 0.2.
booleanValue() - Method in enum org.jenetics.BitGene
Return the boolean value of this gene.
BoundedChromosome<A extends Comparable<? super A>,G extends BoundedGene<A,G>> - Interface in org.jenetics
Chromosome interface for BoundedGenes.
BoundedGene<A extends Comparable<? super A>,G extends BoundedGene<A,G>> - Interface in org.jenetics
Base interface for genes where the alleles are bound by a minimum and a maximum value.
box(boolean...) - Static method in class org.jenetics.util.Array
Boxes the given native array into an Array<Boolean>.
box(char...) - Static method in class org.jenetics.util.Array
Boxes the given native array into an Array<Char>.
box(short...) - Static method in class org.jenetics.util.Array
Boxes the given native array into an Array<Short>.
box(int...) - Static method in class org.jenetics.util.Array
Boxes the given native array into an Array<Integer>.
box(long...) - Static method in class org.jenetics.util.Array
Boxes the given native array into an Array<Long>.
box(float...) - Static method in class org.jenetics.util.Array
Boxes the given native array into an Array<Float>.
box(double...) - Static method in class org.jenetics.util.Array
Boxes the given native array into an Array<Double>.
build() - Method in class org.jenetics.NumberStatistics.Builder
 
build() - Method in class org.jenetics.Statistics.Builder
Return a new Statistics object with the builder values.
byteValue(int) - Method in interface org.jenetics.NumericChromosome
Return the byte value of this NumericChromosome at the given index.
byteValue() - Method in interface org.jenetics.NumericChromosome
Return the byte value of this NumericChromosome at the index 0.
byteValue() - Method in interface org.jenetics.NumericGene
Returns the value of the specified gene as an byte.

C

CharacterChromosome - Class in org.jenetics
CharacterChromosome which represents character sequences.
CharacterChromosome(ISeq<CharacterGene>) - Constructor for class org.jenetics.CharacterChromosome
Create a new chromosome from the given genes array.
CharacterChromosome(CharSeq, int) - Constructor for class org.jenetics.CharacterChromosome
Create a new chromosome with the validCharacters char set as valid characters.
CharacterGene - Class in org.jenetics
Character gene implementation.
CharacterGene(Character, CharSeq) - Constructor for class org.jenetics.CharacterGene
Create a new character gene from the given character and the given set of valid characters.
charAt(int) - Method in class org.jenetics.CharacterChromosome
 
charAt(int) - Method in class org.jenetics.util.CharSeq
 
CharSeq - Class in org.jenetics.util
This class is used for holding the valid characters of an CharacterGene.
CharSeq(char[]) - Constructor for class org.jenetics.util.CharSeq
Create a new (distinct) CharSeq from the given characters.
CharSeq(CharSequence) - Constructor for class org.jenetics.util.CharSeq
Create a new (distinct) CharSeq from the given characters.
charValue() - Method in class org.jenetics.CharacterGene
Return the char value of this character gene.
chisqr(Function<C, Double>) - Method in class org.jenetics.stat.Histogram
 
chisqr(Function<C, Double>, C, C) - Method in class org.jenetics.stat.Histogram
 
Chromosome<G extends Gene<?,G>> - Interface in org.jenetics
A chromosome consists of one or more genes.
Chromosome(int) - Static method in class org.jenetics.Genotype
Return a converter which access the chromosome with the given index of this genotype.
Chromosome() - Static method in class org.jenetics.Genotype
Return a converter which access the first chromosome of this genotype.
Chromosomes() - Static method in class org.jenetics.Genotype
Return a converter which access the chromosome array of this genotype.
clamp(double, double, double) - Static method in class org.jenetics.util.math
Clamping a value between a pair of boundary values.
clear() - Method in class org.jenetics.Population
 
clone() - Method in class org.jenetics.stat.Histogram
 
clone() - Method in class org.jenetics.stat.Mean
 
clone() - Method in class org.jenetics.stat.Quantile
 
clone() - Method in class org.jenetics.stat.Variance
 
clone() - Method in class org.jenetics.util.accumulators.Max
 
clone() - Method in class org.jenetics.util.accumulators.Min
 
clone() - Method in class org.jenetics.util.accumulators.MinMax
 
clone() - Method in class org.jenetics.util.MappedAccumulator
 
clone() - Method in class org.jenetics.util.Timer
 
close() - Method in interface org.jenetics.util.Scoped
Closing this scope and restoring the original state.
combine - Variable in class org.jenetics.Statistics.Time
Combination time between offspring and survivors.
compare(T, T) - Method in enum org.jenetics.Optimize
Compares two comparable objects.
compareTo(BitChromosome) - Method in class org.jenetics.BitChromosome
 
compareTo(CharacterGene) - Method in class org.jenetics.CharacterGene
 
compareTo(EnumGene<A>) - Method in class org.jenetics.EnumGene
 
compareTo(Phenotype<G, C>) - Method in class org.jenetics.Phenotype
 
compareTo(CharSeq) - Method in class org.jenetics.util.CharSeq
 
compareTo(Duration) - Method in class org.jenetics.util.Duration
 
compareTo(Timer) - Method in class org.jenetics.util.Timer
 
complement(byte[]) - Static method in class org.jenetics.util.bit
Make the two's complement of the given data array.
compose(Function<A, B>, Function<B, C>) - Static method in class org.jenetics.util.functions
 
compose(Function<A, B>, Function<B, C>, Function<C, D>) - Static method in class org.jenetics.util.functions
 
compose(Function<A, B>, Function<B, C>, Function<C, D>, Function<D, E>) - Static method in class org.jenetics.util.functions
 
compose(Function<A, B>, Function<B, C>, Function<C, D>, Function<D, E>, Function<E, F>) - Static method in class org.jenetics.util.functions
 
CompositeAlterer<G extends Gene<?,G>> - Class in org.jenetics
Combines several alterers to one.
CompositeAlterer(Seq<Alterer<G>>) - Constructor for class org.jenetics.CompositeAlterer
Combine the given alterers.
contains(Object) - Method in class org.jenetics.Population
 
contains(Object) - Method in class org.jenetics.util.CharSeq
 
contains(Character) - Method in class org.jenetics.util.CharSeq
Test whether this character set contains the given character c.
contains(char) - Method in class org.jenetics.util.CharSeq
Test whether this character set contains the given character c.
contains(C) - Method in class org.jenetics.util.Range
 
contains(Object) - Method in interface org.jenetics.util.Seq
Returns true if this sequence contains the specified element.
containsAll(Collection<?>) - Method in class org.jenetics.Population
 
copy() - Method in class org.jenetics.Population
 
copy() - Method in class org.jenetics.util.Array
 
copy() - Method in interface org.jenetics.util.Copyable
Return a new copy of type T.
copy() - Method in interface org.jenetics.util.ISeq
Return a shallow copy of this sequence.
Copyable<T> - Interface in org.jenetics.util
 
count(byte[]) - Static method in class org.jenetics.util.bit
Returns the number of one-bits in the given byte array.
count(byte) - Static method in class org.jenetics.util.bit
Returns the number of one-bits in the given byte value.
Crossover<G extends Gene<?,G>> - Class in org.jenetics
Performs a Crossover of two Chromosome.
Crossover(double) - Constructor for class org.jenetics.Crossover
Constructs an alterer with a given recombination probability.
crossover(MSeq<G>, MSeq<G>) - Method in class org.jenetics.Crossover
Template method which performs the crossover.
crossover(MSeq<G>, MSeq<G>) - Method in class org.jenetics.MultiPointCrossover
 
crossover(MSeq<EnumGene<T>>, MSeq<EnumGene<T>>) - Method in class org.jenetics.PartiallyMatchedCrossover
 
crossover(MSeq<G>, MSeq<G>) - Method in class org.jenetics.SinglePointCrossover
 

D

DEFAULT - Static variable in class org.jenetics.util.LCG64ShiftRandom.Param
The default PRNG parameters: a = 0xFBD19FBBC5C07FF5L; b = 1
DEFAULT_ALTER_PROBABILITY - Static variable in class org.jenetics.AbstractAlterer
 
DEFAULT_CHARACTERS - Static variable in class org.jenetics.CharacterGene
The default character set used by this gene.
DEFAULT_MAXIMAL_PHENOTYPE_AGE - Static variable in class org.jenetics.GeneticAlgorithm
The default maximal phenotype age of this GA:
DEFAULT_OFFSPRING_FRACTION - Static variable in class org.jenetics.GeneticAlgorithm
The default offspring fraction used by this GA.
DEFAULT_POPULATION_SIZE - Static variable in class org.jenetics.GeneticAlgorithm
The default population size used by this GA.
descending() - Method in enum org.jenetics.Optimize
Create an appropriate comparator of the given optimization strategy.
Distribution<C extends Comparable<? super C>> - Interface in org.jenetics.stat
Defines the domain, PDF and CDF of a probability distribution.
divide(double[], double) - Static method in class org.jenetics.util.math
Component wise division of the given double array.
DoubleChromosome - Class in org.jenetics
Numeric chromosome implementation which holds 64 bit floating point numbers.
DoubleChromosome(ISeq<DoubleGene>) - Constructor for class org.jenetics.DoubleChromosome
 
DoubleChromosome(Double, Double, int) - Constructor for class org.jenetics.DoubleChromosome
Create a new random DoubleChromosome.
DoubleChromosome(Double, Double) - Constructor for class org.jenetics.DoubleChromosome
Create a new random DoubleChromosome of length one.
DoubleGene - Class in org.jenetics
Implementation of the NumericGene which holds a 64 bit floating point number.
DoubleGene(Double, Double, Double) - Constructor for class org.jenetics.DoubleGene
Create a new random DoubleGene with the given value and the given range.
doubleValue() - Method in class org.jenetics.BitChromosome
Return the double value this BitChromosome represents.
doubleValue(int) - Method in interface org.jenetics.NumericChromosome
Return the double value of this NumericChromosome at the given index.
doubleValue() - Method in interface org.jenetics.NumericChromosome
Return the double value of this NumericChromosome at the index 0.
doubleValue() - Method in interface org.jenetics.NumericGene
Returns the value of the specified gene as an double.
Duration - Class in org.jenetics.util
This class models a quantity or amount of time, such as '34.5 seconds'.

E

empty() - Static method in class org.jenetics.util.Array
Return the empty array.
EnumGene<A> - Class in org.jenetics
Gene which holds enumerable (countable) genes.
EnumGene(int, ISeq<? extends A>) - Constructor for class org.jenetics.EnumGene
Create a new enum gene from the given valid genes and the chosen allele index.
equals(Object) - Method in class org.jenetics.AbstractAlterer
 
equals(Object) - Method in class org.jenetics.AbstractChromosome
 
equals(Object) - Method in class org.jenetics.BitChromosome
 
equals(Object) - Method in class org.jenetics.BoltzmannSelector
 
equals(Object) - Method in class org.jenetics.CharacterChromosome
 
equals(Object) - Method in class org.jenetics.CharacterGene
 
equals(Object) - Method in class org.jenetics.CompositeAlterer
 
equals(Object) - Method in class org.jenetics.DoubleChromosome
 
equals(Object) - Method in class org.jenetics.EnumGene
 
equals(Object) - Method in class org.jenetics.ExponentialRankSelector
 
equals(Object) - Method in class org.jenetics.ExponentialScaler
 
equals(Object) - Method in class org.jenetics.GaussianMutator
 
equals(Object) - Method in class org.jenetics.Genotype
 
equals(Object) - Method in class org.jenetics.IntegerChromosome
 
equals(Object) - Method in class org.jenetics.LinearRankSelector
 
equals(Object) - Method in class org.jenetics.LongChromosome
 
equals(Object) - Method in class org.jenetics.MeanAlterer
 
equals(Object) - Method in class org.jenetics.MonteCarloSelector
 
equals(Object) - Method in class org.jenetics.MultiPointCrossover
 
equals(Object) - Method in class org.jenetics.Mutator
 
equals(Object) - Method in class org.jenetics.NumberStatistics
 
equals(Object) - Method in class org.jenetics.PartiallyMatchedCrossover
 
equals(Object) - Method in class org.jenetics.PermutationChromosome
 
equals(Object) - Method in class org.jenetics.Phenotype
 
equals(Object) - Method in class org.jenetics.Population
 
equals(Object) - Method in class org.jenetics.RouletteWheelSelector
 
equals(Object) - Method in class org.jenetics.SinglePointCrossover
 
equals(Object) - Method in class org.jenetics.stat.Histogram
 
equals(Object) - Method in class org.jenetics.stat.LinearDistribution
 
equals(Object) - Method in class org.jenetics.stat.Mean
 
equals(Object) - Method in class org.jenetics.stat.NormalDistribution
 
equals(Object) - Method in class org.jenetics.stat.Quantile
 
equals(Object) - Method in class org.jenetics.stat.UniformDistribution
 
equals(Object) - Method in class org.jenetics.stat.Variance
 
equals(Object) - Method in class org.jenetics.Statistics
 
equals(Object) - Method in class org.jenetics.Statistics.Time
 
equals(Object) - Method in class org.jenetics.StochasticUniversalSelector
 
equals(Object) - Method in class org.jenetics.SwapMutator
 
equals(Object) - Method in class org.jenetics.TournamentSelector
 
equals(Object) - Method in class org.jenetics.TruncationSelector
 
equals(Object) - Method in class org.jenetics.util.accumulators.Max
 
equals(Object) - Method in class org.jenetics.util.accumulators.Min
 
equals(Object) - Method in class org.jenetics.util.accumulators.MinMax
 
equals(Seq<?>, Object) - Static method in class org.jenetics.util.arrays
Unified method for compare to sequences for equality.
equals(Object) - Method in class org.jenetics.util.CharSeq
 
equals(Object) - Method in class org.jenetics.util.Duration
 
equals(Object) - Method in class org.jenetics.util.FinalReference
 
equals(Object) - Method in class org.jenetics.util.LCG64ShiftRandom
 
equals(Object) - Method in class org.jenetics.util.LCG64ShiftRandom.Param
 
equals(Object) - Method in class org.jenetics.util.MappedAccumulator
 
equals(Object) - Method in interface org.jenetics.util.Seq
Compares the specified object with this sequence for equality.
equals(Object) - Method in class org.jenetics.util.Timer
 
evaluate(Executor, Iterable<? extends Phenotype<G, R>>, int, Optimize) - Method in class org.jenetics.NumberStatistics.Calculator
 
evaluate() - Method in class org.jenetics.Phenotype
Evaluates the (raw) fitness values and caches it so the fitness calculation is performed only once.
evaluate(Executor, Iterable<? extends Phenotype<G, C>>, int, Optimize) - Method in class org.jenetics.Statistics.Calculator
Create a new statistics object from the given population at the given generation.
evaluation - Variable in class org.jenetics.Statistics.Time
The evaluation time.
evolve() - Method in class org.jenetics.GeneticAlgorithm
Evolve one generation.
evolve(int) - Method in class org.jenetics.GeneticAlgorithm
Evolve the given number of generations
evolve(Function<? super Statistics<G, C>, Boolean>) - Method in class org.jenetics.GeneticAlgorithm
Evolve the GA as long the given Function returns true.
execution - Variable in class org.jenetics.Statistics.Time
The overall execution time.
expand(CharSequence) - Static method in class org.jenetics.util.CharSeq
Expands the character range for the given pattern.
expand(char, char) - Static method in class org.jenetics.util.CharSeq
Expands the characters between a and b.
ExponentialRankSelector<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
An alternative to the "weak" LinearRankSelector is to assign survival probabilities to the sorted individuals using an exponential function.
ExponentialRankSelector(double) - Constructor for class org.jenetics.ExponentialRankSelector
Create a new exponential rank selector.
ExponentialScaler - Class in org.jenetics
Implements an exponential fitness scaling, whereby all fitness values are modified the following way.
ExponentialScaler(double, double, double) - Constructor for class org.jenetics.ExponentialScaler
Create a new FitnessScaler.
ExponentialScaler(double, double) - Constructor for class org.jenetics.ExponentialScaler
Create a new FitnessScaler.
ExponentialScaler(double) - Constructor for class org.jenetics.ExponentialScaler
Create a new FitnessScaler.

F

Factory<T> - Interface in org.jenetics.util
 
fill(Factory<Phenotype<G, C>>, int) - Method in class org.jenetics.Population
Fills the population with individuals created by the given factory.
fill(Factory<? extends T>) - Method in class org.jenetics.util.Array
 
fill(Factory<? extends T>) - Method in interface org.jenetics.util.MSeq
Fill the sequence with values generated by the given factory.
filter(Function<? super T, Boolean>) - Method in class org.jenetics.util.Array
Selects all elements of this list which satisfy a predicate.
FinalReference<T> - Class in org.jenetics.util
A final reference.
FinalReference() - Constructor for class org.jenetics.util.FinalReference
Create a new final reference.
FinalReference(T) - Constructor for class org.jenetics.util.FinalReference
Create a new FinalReference with the given default value.
Fitness() - Static method in class org.jenetics.Phenotype
Create a Function which return the phenotype fitness when calling converter.convert(phenotype).
fitnessMean(double) - Method in class org.jenetics.NumberStatistics.Builder
 
fitnessVariance(double) - Method in class org.jenetics.NumberStatistics.Builder
 
flip(byte[], int) - Static method in class org.jenetics.util.bit
Flip the bit at the given index.
floatValue() - Method in class org.jenetics.BitChromosome
Return the float value this BitChromosome represents.
floatValue(int) - Method in interface org.jenetics.NumericChromosome
Return the float value of this NumericChromosome at the given index.
floatValue() - Method in interface org.jenetics.NumericChromosome
Return the float value of this NumericChromosome at the index 0.
floatValue() - Method in interface org.jenetics.NumericGene
Returns the value of the specified gene as an float.
forAll(Function<? super T, Boolean>) - Method in interface org.jenetics.util.Seq
Tests whether a predicate holds for all elements of this sequence.
forEach(T[], Function<? super T, ? extends R>) - Static method in class org.jenetics.util.arrays
Iterates over all elements of the given array as long as the predicate returns true (which means continue) and returns the index the iteration has been interrupted.
forEach(Iterable<? extends T>, Function<? super T, ? extends R>) - Static method in class org.jenetics.util.arrays
Iterates over all elements of the given values
forEach(Function<? super T, ? extends R>) - Method in interface org.jenetics.util.Seq
Applies a function to all elements of this sequence.
fromByteString(String) - Static method in class org.jenetics.util.bit
Convert a string which was created with the bit.toByteString(byte...) method back to an byte array.
Function<T,R> - Interface in org.jenetics.util
A function of 1 parameter.
functions - Class in org.jenetics.util
This class contains some short general purpose functions.

G

GaussianMutator<G extends NumericGene<?,G>> - Class in org.jenetics
The GaussianMutator class performs the mutation of a NumericGene.
GaussianMutator() - Constructor for class org.jenetics.GaussianMutator
 
GaussianMutator(double) - Constructor for class org.jenetics.GaussianMutator
 
Gene - Static variable in class org.jenetics.CharacterChromosome
Return a Function which returns the first Gene from this Chromosome.
Gene(int) - Static method in class org.jenetics.CharacterChromosome
Return a Function which returns the Gene with the given index from this Chromosome.
Gene<A,G extends Gene<A,G>> - Interface in org.jenetics
Genes are the atoms of the Jenetics library.
Generation() - Static method in class org.jenetics.Phenotype
Create a Function which return the phenotype generation when calling converter.convert(phenotype).
generation(int) - Method in class org.jenetics.Statistics.Builder
 
Generation(int) - Static method in class org.jenetics.termination
Return a termination predicate which returns false if the current GA generation is >= as the given generation.
Genes - Static variable in class org.jenetics.CharacterChromosome
Return a Function which returns the gene array from this Chromosome.
GeneticAlgorithm<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
Getting started
GeneticAlgorithm(Factory<Genotype<G>>, Function<? super Genotype<G>, ? extends C>, Function<? super C, ? extends C>, Optimize, Executor) - Constructor for class org.jenetics.GeneticAlgorithm
Create a new genetic algorithm.
GeneticAlgorithm(Factory<Genotype<G>>, Function<? super Genotype<G>, ? extends C>, Function<? super C, ? extends C>, Optimize) - Constructor for class org.jenetics.GeneticAlgorithm
Create a new genetic algorithm.
GeneticAlgorithm(Factory<Genotype<G>>, Function<? super Genotype<G>, ? extends C>, Optimize, Executor) - Constructor for class org.jenetics.GeneticAlgorithm
Create a new genetic algorithm.
GeneticAlgorithm(Factory<Genotype<G>>, Function<? super Genotype<G>, ? extends C>, Optimize) - Constructor for class org.jenetics.GeneticAlgorithm
Create a new genetic algorithm.
GeneticAlgorithm(Factory<Genotype<G>>, Function<? super Genotype<G>, ? extends C>, Executor) - Constructor for class org.jenetics.GeneticAlgorithm
Create a new genetic algorithm.
GeneticAlgorithm(Factory<Genotype<G>>, Function<? super Genotype<G>, ? extends C>) - Constructor for class org.jenetics.GeneticAlgorithm
Create a new genetic algorithm.
GeneticAlgorithm(Factory<Genotype<G>>, Function<? super Genotype<G>, ? extends C>, Function<? super C, ? extends C>, Executor) - Constructor for class org.jenetics.GeneticAlgorithm
Create a new genetic algorithm.
GeneticAlgorithm(Factory<Genotype<G>>, Function<? super Genotype<G>, ? extends C>, Function<? super C, ? extends C>) - Constructor for class org.jenetics.GeneticAlgorithm
Create a new genetic algorithm.
Genotype<G extends Gene<?,G>> - Class in org.jenetics
The central class the GA is working with, is the Genotype.
Genotype(ISeq<? extends Chromosome<G>>) - Constructor for class org.jenetics.Genotype
Create a new Genotype from a given sequence of Chromosomes.
Genotype() - Static method in class org.jenetics.Phenotype
Create a Function which return the phenotype genotype when calling converter.convert(phenotype).
get() - Method in class org.jenetics.BitChromosome
Return the value of the first gene of this chromosome.
get(int) - Method in class org.jenetics.BitChromosome
Return the value on the specified index.
get(int) - Method in class org.jenetics.Population
 
get(byte[], int) - Static method in class org.jenetics.util.bit
Return the (boolean) value of the byte array at the given bit index.
get() - Method in class org.jenetics.util.FinalReference
 
get() - Method in interface org.jenetics.util.Scoped
Return the scoped object.
get(int) - Method in interface org.jenetics.util.Seq
Return the value at the given index.
getAge(int) - Method in class org.jenetics.Phenotype
Return the age of this phenotype depending on the given current generation.
getAgeMean() - Method in class org.jenetics.Statistics
Return the average (mean) age of the individuals of the aggregated population.
getAgeVariance() - Method in class org.jenetics.Statistics
Return the age variance of the individuals of the aggregated population.
getAllele() - Method in enum org.jenetics.BitGene
 
getAllele() - Method in class org.jenetics.CharacterGene
 
getAllele() - Method in class org.jenetics.EnumGene
 
getAllele() - Method in interface org.jenetics.Gene
Return the allele of this gene.
getAlleleIndex() - Method in class org.jenetics.EnumGene
Return the index of the allele this gene is representing.
getAlterer() - Method in class org.jenetics.GeneticAlgorithm
Return the currently used Alterer of the GA.
getAlterers() - Method in class org.jenetics.CompositeAlterer
Return the alterers this alterer consists of.
getBestFitness() - Method in class org.jenetics.Statistics
Return the best population fitness.
getBestPhenotype() - Method in class org.jenetics.GeneticAlgorithm
Return the best Phenotype so far or null if the GA hasn't been initialized yet.
getBestPhenotype() - Method in class org.jenetics.Statistics
Return the best population Phenotype.
getBestStatistics() - Method in class org.jenetics.GeneticAlgorithm
Return the statistics of the best phenotype.
getBit() - Method in enum org.jenetics.BitGene
Return the value of the BitGene.
getCDF() - Method in interface org.jenetics.stat.Distribution
Return a new instance of the Cumulative Distribution Function (CDF).
getCDF() - Method in class org.jenetics.stat.LinearDistribution
Return a new CDF object.
getCDF() - Method in class org.jenetics.stat.NormalDistribution
Return a new CDF object.
getCDF() - Method in class org.jenetics.stat.UniformDistribution
Return a new CDF object.
getChromosome(int) - Method in class org.jenetics.Genotype
Return the chromosome at the given index.
getChromosome() - Method in class org.jenetics.Genotype
Return the first chromosome.
getComparator() - Method in class org.jenetics.stat.Histogram
Return the comparator used for class search.
getDomain() - Method in interface org.jenetics.stat.Distribution
Return the domain of this probability distribution.
getDomain() - Method in class org.jenetics.stat.LinearDistribution
 
getDomain() - Method in class org.jenetics.stat.NormalDistribution
 
getDomain() - Method in class org.jenetics.stat.UniformDistribution
 
getFitness() - Method in class org.jenetics.Phenotype
Return the fitness value of this Phenotype.
getFitnessFunction() - Method in class org.jenetics.GeneticAlgorithm
Return the used fitness Function of the GA.
getFitnessFunction() - Method in class org.jenetics.Phenotype
Return the fitness function used by this phenotype to calculate the (raw) fitness value.
getFitnessMean() - Method in class org.jenetics.NumberStatistics
Return the mean of the fitness values.
getFitnessScaler() - Method in class org.jenetics.GeneticAlgorithm
Return the currently used fitness scaler Function of the GA.
getFitnessScaler() - Method in class org.jenetics.Phenotype
Return the fitness scaler used by this phenotype to scale the raw fitness.
getFitnessVariance() - Method in class org.jenetics.NumberStatistics
Return the variance of the fitness values.
getGene(int) - Method in class org.jenetics.AbstractChromosome
 
getGene() - Method in class org.jenetics.AbstractChromosome
 
getGene() - Method in class org.jenetics.BitChromosome
 
getGene(int) - Method in class org.jenetics.BitChromosome
 
getGene() - Method in interface org.jenetics.Chromosome
Return the first gene of this chromosome.
getGene(int) - Method in interface org.jenetics.Chromosome
Return the gene on the specified index.
getGene() - Method in class org.jenetics.Genotype
Return the first Gene of the first Chromosome of this Genotype.
getGeneration() - Method in class org.jenetics.GeneticAlgorithm
Return the current overall generation.
getGeneration() - Method in class org.jenetics.Phenotype
Return the generation this Phenotype was created.
getGeneration() - Method in class org.jenetics.Statistics
Return the generation of this statistics.
getGenotype() - Method in class org.jenetics.Phenotype
This method returns a copy of the Genotype, to guarantee a immutable class.
getGenotypeFactory() - Method in class org.jenetics.GeneticAlgorithm
Return the used genotype Factory of the GA.
getGenotypes() - Method in class org.jenetics.Population
 
getHistogram(long[]) - Method in class org.jenetics.stat.Histogram
Copy the histogram into the given array.
getHistogram() - Method in class org.jenetics.stat.Histogram
Return a copy of the current histogram.
getInterimTime() - Method in class org.jenetics.util.Timer
Return the time between two successive calls of Timer.start() and Timer.stop().
getInvalid() - Method in class org.jenetics.Statistics
Return the number of invalid individuals.
getKilled() - Method in class org.jenetics.Statistics
Return the number of killed individuals.
getLabel() - Method in class org.jenetics.util.Timer
Return the timer label.
getLock() - Method in class org.jenetics.GeneticAlgorithm
If you are using the GeneticAlgorithm in an threaded environment and you want to change some of the GAs parameters you can use the returned Lock to synchronize your parameter changes.
getMax() - Method in interface org.jenetics.BoundedChromosome
Return the maximum value of this BoundedChromosome.
getMax() - Method in interface org.jenetics.BoundedGene
Return the allowed max value.
getMax() - Method in class org.jenetics.util.accumulators.Max
Return the max value, accumulated so far.
getMax() - Method in class org.jenetics.util.accumulators.MinMax
Return the max value, accumulated so far.
getMax() - Method in class org.jenetics.util.Range
 
getMaximalPhenotypeAge() - Method in class org.jenetics.GeneticAlgorithm
Return the maximal age of the Phenotypes.
getMean() - Method in class org.jenetics.stat.Mean
Return the mean value of the accumulated values.
getMin() - Method in interface org.jenetics.BoundedChromosome
Return the minimum value of this BoundedChromosome.
getMin() - Method in interface org.jenetics.BoundedGene
Return the allowed min value.
getMin() - Method in class org.jenetics.util.accumulators.Min
Return the min value, accumulated so far.
getMin() - Method in class org.jenetics.util.accumulators.MinMax
Return the min value, accumulated so far.
getMin() - Method in class org.jenetics.util.Range
 
getN() - Method in class org.jenetics.MultiPointCrossover
Return the number of crossover points.
getNumberOfGenes() - Method in class org.jenetics.Genotype
Return the number of genes this genotype consists of.
getNumberOfInvalidPhenotypes() - Method in class org.jenetics.GeneticAlgorithm
Return the number of invalid phenotypes, so far.
getNumberOfKilledPhenotypes() - Method in class org.jenetics.GeneticAlgorithm
Return the number of killed phenotypes, so far.
getOffspringFraction() - Method in class org.jenetics.GeneticAlgorithm
Return the currently used offspring fraction of the GA.
getOffspringSelector() - Method in class org.jenetics.GeneticAlgorithm
Return the currently used offspring Selector of the GA.
getOptimize() - Method in class org.jenetics.Statistics
Return the optimize strategy of the GA.
getOrder() - Method in class org.jenetics.Recombinator
Return the number of individuals involved in the Recombinator.recombine(Population, int[], int) step.
getPDF() - Method in interface org.jenetics.stat.Distribution
Return a new instance of the Probability Density Function (PDF).
getPDF() - Method in class org.jenetics.stat.LinearDistribution
Return a new PDF object.
getPDF() - Method in class org.jenetics.stat.NormalDistribution
Return a new PDF object.
getPDF() - Method in class org.jenetics.stat.UniformDistribution
Return a new PDF object.
getPopulation() - Method in class org.jenetics.GeneticAlgorithm
Return a copy of the current population.
getPopulationSize() - Method in class org.jenetics.GeneticAlgorithm
Return the desired population size of the GA.
getProbabilities() - Method in class org.jenetics.stat.Histogram
Return the histogram as probability array.
getProbability() - Method in class org.jenetics.AbstractAlterer
Return the recombination/alter probability for this alterer.
getRandom() - Static method in class org.jenetics.util.RandomRegistry
Return the global Random object.
getRawFitness() - Method in class org.jenetics.Phenotype
Return the raw fitness (before scaling) of the phenotype.
getSamples() - Method in class org.jenetics.Statistics
Return the number of samples this statistics has aggregated.
getSamples() - Method in class org.jenetics.util.MappedAccumulator
Return the number of samples accumulated so far.
getSeparators() - Method in class org.jenetics.stat.Histogram
Return a copy of the class separators.
getStandardError() - Method in class org.jenetics.NumberStatistics
Return the Standard error of the calculated fitness mean.
getStandardError() - Method in class org.jenetics.stat.Mean
Return the Standard error of the calculated mean.
getStatistics() - Method in class org.jenetics.GeneticAlgorithm
Return the current Population Statistics or null if the GA hasn't been initialized yet.
getStatisticsCalculator() - Method in class org.jenetics.GeneticAlgorithm
Return the current statistics calculator.
getSurvivorSelector() - Method in class org.jenetics.GeneticAlgorithm
Return the currently used survivor Selector of the GA.
getTime() - Method in class org.jenetics.Statistics
Return the time statistic object which contains the durations of the different GA execution steps.
getTime() - Method in class org.jenetics.util.Timer
Return the overall time of this timer.
getTimeStatistics() - Method in class org.jenetics.GeneticAlgorithm
Return the current time statistics of the GA.
getValidAlleles() - Method in class org.jenetics.EnumGene
Return sequence of the valid alleles where this gene is a part of.
getValidAlleles() - Method in class org.jenetics.PermutationChromosome
 
getValidCharacters() - Method in class org.jenetics.CharacterGene
Return a (unmodifiable) set of valid characters.
getValue() - Method in class org.jenetics.stat.Quantile
Return the computed quantile value.
getVariance() - Method in class org.jenetics.stat.Variance
Return the variance of the accumulated values.
getWorstFitness() - Method in class org.jenetics.Statistics
Return the worst population fitness.
getWorstPhenotype() - Method in class org.jenetics.Statistics
Return the worst population Phenotype.

H

hashCode() - Method in class org.jenetics.AbstractAlterer
 
hashCode() - Method in class org.jenetics.AbstractChromosome
 
hashCode() - Method in class org.jenetics.BitChromosome
 
hashCode() - Method in class org.jenetics.BoltzmannSelector
 
hashCode() - Method in class org.jenetics.CharacterChromosome
 
hashCode() - Method in class org.jenetics.CharacterGene
 
hashCode() - Method in class org.jenetics.CompositeAlterer
 
hashCode() - Method in class org.jenetics.DoubleChromosome
 
hashCode() - Method in class org.jenetics.EnumGene
 
hashCode() - Method in class org.jenetics.ExponentialRankSelector
 
hashCode() - Method in class org.jenetics.ExponentialScaler
 
hashCode() - Method in class org.jenetics.GaussianMutator
 
hashCode() - Method in class org.jenetics.Genotype
 
hashCode() - Method in class org.jenetics.IntegerChromosome
 
hashCode() - Method in class org.jenetics.LinearRankSelector
 
hashCode() - Method in class org.jenetics.LongChromosome
 
hashCode() - Method in class org.jenetics.MeanAlterer
 
hashCode() - Method in class org.jenetics.MonteCarloSelector
 
hashCode() - Method in class org.jenetics.MultiPointCrossover
 
hashCode() - Method in class org.jenetics.Mutator
 
hashCode() - Method in class org.jenetics.NumberStatistics
 
hashCode() - Method in class org.jenetics.PartiallyMatchedCrossover
 
hashCode() - Method in class org.jenetics.PermutationChromosome
 
hashCode() - Method in class org.jenetics.Phenotype
 
hashCode() - Method in class org.jenetics.Population
 
hashCode() - Method in class org.jenetics.RouletteWheelSelector
 
hashCode() - Method in class org.jenetics.SinglePointCrossover
 
hashCode() - Method in class org.jenetics.stat.Histogram
 
hashCode() - Method in class org.jenetics.stat.LinearDistribution
 
hashCode() - Method in class org.jenetics.stat.Mean
 
hashCode() - Method in class org.jenetics.stat.NormalDistribution
 
hashCode() - Method in class org.jenetics.stat.Quantile
 
hashCode() - Method in class org.jenetics.stat.UniformDistribution
 
hashCode() - Method in class org.jenetics.stat.Variance
 
hashCode() - Method in class org.jenetics.Statistics
 
hashCode() - Method in class org.jenetics.Statistics.Time
 
hashCode() - Method in class org.jenetics.StochasticUniversalSelector
 
hashCode() - Method in class org.jenetics.SwapMutator
 
hashCode() - Method in class org.jenetics.TournamentSelector
 
hashCode() - Method in class org.jenetics.TruncationSelector
 
hashCode() - Method in class org.jenetics.util.accumulators.Max
 
hashCode() - Method in class org.jenetics.util.accumulators.Min
 
hashCode() - Method in class org.jenetics.util.accumulators.MinMax
 
hashCode(Seq<?>) - Static method in class org.jenetics.util.arrays
Unified method for calculating the hash code of every Seq implementation.
hashCode() - Method in class org.jenetics.util.CharSeq
 
hashCode() - Method in class org.jenetics.util.Duration
 
hashCode() - Method in class org.jenetics.util.FinalReference
 
hashCode() - Method in class org.jenetics.util.LCG64ShiftRandom
 
hashCode() - Method in class org.jenetics.util.LCG64ShiftRandom.Param
 
hashCode() - Method in class org.jenetics.util.MappedAccumulator
 
hashCode() - Method in class org.jenetics.util.Range
 
hashCode() - Method in interface org.jenetics.util.Seq
Returns the hash code value for this sequence.
hashCode() - Method in class org.jenetics.util.Timer
 
Histogram<C> - Class in org.jenetics.stat
To create an Histogram Accumulator you have to define the class border which define the histogram classes.
Histogram(Comparator<C>, C...) - Constructor for class org.jenetics.stat.Histogram
Create a new Histogram with the given class separators.

I

Identity() - Static method in class org.jenetics.util.functions
Return the identity function for the given type.
increment(byte[]) - Static method in class org.jenetics.util.bit
Increment the given data array.
indexOf(Object) - Method in class org.jenetics.AbstractChromosome
Return the index of the first occurrence of the given gene.
indexOf(Object) - Method in class org.jenetics.Population
 
indexOf(Object) - Method in interface org.jenetics.util.Seq
Returns the index of the first occurrence of the specified element in this sequence, or -1 if this sequence does not contain the element.
indexOf(Object, int) - Method in interface org.jenetics.util.Seq
Returns the index of the first occurrence of the specified element in this sequence, or -1 if this sequence does not contain the element.
indexOf(Object, int, int) - Method in interface org.jenetics.util.Seq
Returns the index of the first occurrence of the specified element in this sequence, or -1 if this sequence does not contain the element.
IndexStream - Class in org.jenetics.util
Interface which delivers a stream of (positive) indexes (ints)s.
IndexStream() - Constructor for class org.jenetics.util.IndexStream
 
indexWhere(Function<? super T, Boolean>) - Method in interface org.jenetics.util.Seq
Returns the index of the first element on which the given predicate returns true, or -1 if the predicate returns false for every sequence element.
indexWhere(Function<? super T, Boolean>, int) - Method in interface org.jenetics.util.Seq
Returns the index of the first element on which the given predicate returns true, or -1 if the predicate returns false for every sequence element.
indexWhere(Function<? super T, Boolean>, int, int) - Method in interface org.jenetics.util.Seq
Returns the index of the first element on which the given predicate returns true, or -1 if the predicate returns false for every sequence element.
initialValue() - Method in class org.jenetics.util.LCG64ShiftRandom.ThreadLocal
Create a new PRNG using block splitting for guaranteeing well distributed PRN for every thread.
IntegerChromosome - Class in org.jenetics
Numeric chromosome implementation which holds 32 bit integer numbers.
IntegerChromosome(ISeq<IntegerGene>) - Constructor for class org.jenetics.IntegerChromosome
 
IntegerChromosome(Integer, Integer, int) - Constructor for class org.jenetics.IntegerChromosome
Create a new random IntegerChromosome.
IntegerChromosome(Integer, Integer) - Constructor for class org.jenetics.IntegerChromosome
Create a new random IntegerChromosome of length one.
IntegerGene - Class in org.jenetics
NumericGene implementation which holds a 32 bit integer number.
IntegerGene(Integer, Integer, Integer) - Constructor for class org.jenetics.IntegerGene
Create a new random IntegerGene with the given value and the given range.
intValue() - Method in class org.jenetics.BitChromosome
Return the long value this BitChromosome represents.
intValue(int) - Method in interface org.jenetics.NumericChromosome
Return the int value of this NumericChromosome at the given index.
intValue() - Method in interface org.jenetics.NumericChromosome
Return the int value of this NumericChromosome at the index 0.
intValue() - Method in interface org.jenetics.NumericGene
Returns the value of the specified gene as an int.
invalid(int) - Method in class org.jenetics.Statistics.Builder
 
invert() - Method in class org.jenetics.BitChromosome
Invert the ones and zeros of this bit chromosome.
invert(byte[]) - Static method in class org.jenetics.util.bit
Invert the given data array.
IO - Class in org.jenetics.util
Class for object serialization.
IO() - Constructor for class org.jenetics.util.IO
 
isEmpty() - Method in class org.jenetics.Population
 
isEmpty() - Method in class org.jenetics.util.CharSeq
Test whether this character set is empty.
ISeq<T> - Interface in org.jenetics.util
Immutable, ordered, fixed sized sequence.
isFinal() - Method in class org.jenetics.util.FinalReference
Test whether this reference can be set without throwing an IllegalStateException or not.
isInitialized() - Method in class org.jenetics.GeneticAlgorithm
Return true if the GeneticAlgorithm.setup() method has already been called, false otherwise.
isSorted(Seq<T>) - Static method in class org.jenetics.util.arrays
Test whether the given array is sorted in ascending order.
isSorted(Seq<T>, Comparator<? super T>) - Static method in class org.jenetics.util.arrays
Test whether the given array is sorted in ascending order.
isValid() - Method in class org.jenetics.AbstractChromosome
 
isValid() - Method in class org.jenetics.BitChromosome
 
isValid() - Method in enum org.jenetics.BitGene
Return always true.
isValid() - Method in class org.jenetics.CharacterGene
 
isValid() - Method in class org.jenetics.EnumGene
 
isValid() - Method in class org.jenetics.Genotype
Test if this genotype is valid.
isValid() - Method in class org.jenetics.PermutationChromosome
Check if this chromosome represents still a valid permutation.
isValid() - Method in class org.jenetics.Phenotype
Test whether this phenotype is valid.
isValid() - Method in interface org.jenetics.util.Verifiable
Check if this object is valid.
isValidCharacter(Character) - Method in class org.jenetics.CharacterGene
Test, if the given character is valid.
iterator() - Method in class org.jenetics.AbstractChromosome
 
iterator() - Method in class org.jenetics.BitChromosome
 
iterator() - Method in class org.jenetics.Genotype
 
iterator() - Method in class org.jenetics.Population
 
iterator() - Method in class org.jenetics.util.CharSeq
 
iterator(Function<? super T, ? extends B>) - Method in interface org.jenetics.util.Seq
Return an iterator with the new type B.

J

jaxb - Static variable in class org.jenetics.util.IO
JAXB for XML serialization.
join(Alterer<T>, Alterer<T>) - Static method in class org.jenetics.CompositeAlterer
Joins the given alterer and returns a new CompositeAlterer object.
jump(long) - Method in class org.jenetics.util.LCG64ShiftRandom
Changes the internal state of the PRNG in such a way that the engine jumps s steps ahead.
jump(long) - Method in class org.jenetics.util.LCG64ShiftRandom.ThreadSafe
 
jump2(int) - Method in class org.jenetics.util.LCG64ShiftRandom
Changes the internal state of the PRNG in such a way that the engine jumps 2s steps ahead.
jump2(int) - Method in class org.jenetics.util.LCG64ShiftRandom.ThreadSafe
 

K

killed(int) - Method in class org.jenetics.Statistics.Builder
 

L

lastIndexOf(Object) - Method in class org.jenetics.Population
 
lastIndexOf(Object) - Method in interface org.jenetics.util.Seq
Returns the index of the last occurrence of the specified element in this sequence, or -1 if this sequence does not contain the element.
lastIndexOf(Object, int) - Method in interface org.jenetics.util.Seq
Returns the index of the last occurrence of the specified element in this sequence, or -1 if this sequence does not contain the element.
lastIndexOf(Object, int, int) - Method in interface org.jenetics.util.Seq
Returns the index of the last occurrence of the specified element in this sequence, or -1 if this sequence does not contain the element.
lastIndexWhere(Function<? super T, Boolean>) - Method in interface org.jenetics.util.Seq
Returns the index of the last element on which the given predicate returns true, or -1 if the predicate returns false for every sequence element.
lastIndexWhere(Function<? super T, Boolean>, int) - Method in interface org.jenetics.util.Seq
Returns the index of the last element on which the given predicate returns true, or -1 if the predicate returns false for every sequence element.
lastIndexWhere(Function<? super T, Boolean>, int, int) - Method in interface org.jenetics.util.Seq
Returns the index of the last element on which the given predicate returns true, or -1 if the predicate returns false for every sequence element.
LCG64ShiftRandom - Class in org.jenetics.util
This class implements a linear congruential PRNG with additional bit-shift transition.
LCG64ShiftRandom() - Constructor for class org.jenetics.util.LCG64ShiftRandom
Create a new PRNG instance with LCG64ShiftRandom.Param.DEFAULT parameter and safe seed.
LCG64ShiftRandom(long) - Constructor for class org.jenetics.util.LCG64ShiftRandom
Create a new PRNG instance with LCG64ShiftRandom.Param.DEFAULT parameter and the given seed.
LCG64ShiftRandom(LCG64ShiftRandom.Param) - Constructor for class org.jenetics.util.LCG64ShiftRandom
Create a new PRNG instance with the given parameter and a safe seed
LCG64ShiftRandom(long, LCG64ShiftRandom.Param) - Constructor for class org.jenetics.util.LCG64ShiftRandom
Create a new PRNG instance with the given parameter and seed.
LCG64ShiftRandom.Param - Class in org.jenetics.util
Parameter class for the LCG64ShiftRandom generator, for the parameters a and b of the LC recursion ri+1 = a · ri + b mod 264.
LCG64ShiftRandom.Param(long, long) - Constructor for class org.jenetics.util.LCG64ShiftRandom.Param
Create a new parameter object.
LCG64ShiftRandom.ThreadLocal - Class in org.jenetics.util
This class represents a thread local implementation of the LCG64ShiftRandom PRNG.
LCG64ShiftRandom.ThreadLocal() - Constructor for class org.jenetics.util.LCG64ShiftRandom.ThreadLocal
Create a new thread local instance of the LCG64ShiftRandom PRGN with the DEFAULT parameters.
LCG64ShiftRandom.ThreadLocal(LCG64ShiftRandom.Param) - Constructor for class org.jenetics.util.LCG64ShiftRandom.ThreadLocal
Create a new thread local instance of the LCG64ShiftRandom PRGN with the given parameters.
LCG64ShiftRandom.ThreadSafe - Class in org.jenetics.util
This is a thread safe variation of the this PRGN—by synchronizing the random number generation.
LCG64ShiftRandom.ThreadSafe(long, LCG64ShiftRandom.Param) - Constructor for class org.jenetics.util.LCG64ShiftRandom.ThreadSafe
Create a new PRNG instance with the given parameter and seed.
LCG64ShiftRandom.ThreadSafe(long) - Constructor for class org.jenetics.util.LCG64ShiftRandom.ThreadSafe
Create a new PRNG instance with LCG64ShiftRandom.Param.DEFAULT parameter and the given seed.
LCG64ShiftRandom.ThreadSafe(LCG64ShiftRandom.Param) - Constructor for class org.jenetics.util.LCG64ShiftRandom.ThreadSafe
Create a new PRNG instance with the given parameter and a safe default seed.
LCG64ShiftRandom.ThreadSafe() - Constructor for class org.jenetics.util.LCG64ShiftRandom.ThreadSafe
Create a new PRNG instance with LCG64ShiftRandom.Param.DEFAULT parameter and a safe seed.
LECUYER1 - Static variable in class org.jenetics.util.LCG64ShiftRandom.Param
LEcuyer 1 parameters: a = 0x27BB2EE687B0B0FDL; b = 1
LECUYER2 - Static variable in class org.jenetics.util.LCG64ShiftRandom.Param
LEcuyer 2 parameters: a = 0x2C6FE96EE78B6955L; b = 1
LECUYER3 - Static variable in class org.jenetics.util.LCG64ShiftRandom.Param
LEcuyer 3 parameters: a = 0x369DEA0F31A53F85L; b = 1
length() - Method in class org.jenetics.AbstractChromosome
 
length() - Method in class org.jenetics.BitChromosome
 
length() - Method in interface org.jenetics.Chromosome
Returns the length of the Chromosome.
length() - Method in class org.jenetics.Genotype
Getting the number of chromosomes of this genotype.
length() - Method in class org.jenetics.stat.Histogram
Return the number of classes of this histogram.
length() - Method in class org.jenetics.util.CharSeq
 
length() - Method in interface org.jenetics.util.Seq
Return the length of this sequence.
LinearDistribution<N extends Number & Comparable<? super N>> - Class in org.jenetics.stat
This distribution has the following cdf.
LinearDistribution(Range<N>, double) - Constructor for class org.jenetics.stat.LinearDistribution
 
LinearRankSelector<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
In linear-ranking selection the individuals are sorted according to their fitness values.
LinearRankSelector(double) - Constructor for class org.jenetics.LinearRankSelector
Create a new LinearRankSelector with the given values for nminus.
LinearRankSelector() - Constructor for class org.jenetics.LinearRankSelector
Create a new LinearRankSelector with nminus := 0.5.
listIterator() - Method in class org.jenetics.BitChromosome
 
listIterator() - Method in class org.jenetics.Population
 
listIterator(int) - Method in class org.jenetics.Population
 
listIterator() - Method in class org.jenetics.util.Array
 
listIterator() - Method in interface org.jenetics.util.MSeq
Returns a list iterator over the elements in this sequence (in proper sequence).
LongChromosome - Class in org.jenetics
Numeric chromosome implementation which holds 64 bit integer numbers.
LongChromosome(ISeq<LongGene>) - Constructor for class org.jenetics.LongChromosome
 
LongChromosome(Long, Long, int) - Constructor for class org.jenetics.LongChromosome
Create a new random LongChromosome.
LongChromosome(Long, Long) - Constructor for class org.jenetics.LongChromosome
Create a new random LongChromosome of length one.
LongGene - Class in org.jenetics
NumericGene implementation which holds a 64 bit integer number.
LongGene(Long, Long, Long) - Constructor for class org.jenetics.LongGene
Create a new random LongGene with the given value and the given range.
longValue() - Method in class org.jenetics.BitChromosome
Return the long value this BitChromosome represents.
longValue(int) - Method in interface org.jenetics.NumericChromosome
Return the long value of this NumericChromosome at the given index.
longValue() - Method in interface org.jenetics.NumericChromosome
Return the long value of this NumericChromosome at the index 0.
longValue() - Method in interface org.jenetics.NumericGene
Returns the value of the specified gene as an long.

M

map(Function<? super T, ? extends B>) - Method in class org.jenetics.util.Array
 
map(A[], B[], Function<? super A, ? extends B>) - Static method in class org.jenetics.util.arrays
Map the array from type A to an other array of type B.
map(Function<? super T, ? extends B>) - Method in interface org.jenetics.util.ISeq
 
map(Function<? super B, ? extends T>) - Method in class org.jenetics.util.MappedAccumulator
Return a view of this adapter with a different type B.
map(Function<? super T, ? extends B>) - Method in interface org.jenetics.util.MSeq
 
map(Function<? super T, ? extends B>) - Method in interface org.jenetics.util.Seq
Builds a new sequence by applying a function to all elements of this sequence.
MappedAccumulator<T> - Class in org.jenetics.util
Abstract implementation of the Accumulator interface which defines a samples property which is incremented by the MappedAccumulator.accumulate(Object) method.
MappedAccumulator() - Constructor for class org.jenetics.util.MappedAccumulator
 
math - Class in org.jenetics.util
This object contains mathematical helper functions.
math.random - Class in org.jenetics.util
Some helper method concerning random numbers and random seed generation.
math.statistics - Class in org.jenetics.util
Some helper method concerning statistics.
max(double[]) - Static method in class org.jenetics.util.math.statistics
Return the maximum value of the given double array.
mean(DoubleGene) - Method in class org.jenetics.DoubleGene
 
mean(IntegerGene) - Method in class org.jenetics.IntegerGene
 
mean(LongGene) - Method in class org.jenetics.LongGene
 
Mean<N extends Number> - Class in org.jenetics.stat
Calculate the Arithmetic mean from a finite sample of N observations.
Mean() - Constructor for class org.jenetics.stat.Mean
 
Mean<T> - Interface in org.jenetics.util
A mixin interface for genes which can have a mean value.
mean(T) - Method in interface org.jenetics.util.Mean
Return the (usually arithmetic) mean value of this and that.
MeanAlterer<G extends Gene<?,G> & Mean<G>> - Class in org.jenetics
The order (Recombinator.getOrder()) of this Recombination implementation is two.
MeanAlterer(double) - Constructor for class org.jenetics.MeanAlterer
Constructs an alterer with a given recombination probability.
MeanAlterer() - Constructor for class org.jenetics.MeanAlterer
Create a new alterer with alter probability of 0.05.
min(double[]) - Static method in class org.jenetics.util.math.statistics
Return the minimum value of the given double array.
minus(long, long) - Static method in class org.jenetics.util.math
Subtracts to long values and throws an ArithmeticException in the case of an overflow.
MonteCarloSelector<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
The Monte Carlo selector selects the individuals from a given population randomly.
MonteCarloSelector() - Constructor for class org.jenetics.MonteCarloSelector
 
MSeq<T> - Interface in org.jenetics.util
Mutable, ordered, fixed sized sequence.
MultiPointCrossover<G extends Gene<?,G>> - Class in org.jenetics
Multiple point crossover
MultiPointCrossover(double, int) - Constructor for class org.jenetics.MultiPointCrossover
Create a new crossover instance.
MultiPointCrossover(double) - Constructor for class org.jenetics.MultiPointCrossover
Create a new crossover instance with two crossover points.
MultiPointCrossover(int) - Constructor for class org.jenetics.MultiPointCrossover
Create a new crossover instance with default crossover probability of 0.05.
MultiPointCrossover() - Constructor for class org.jenetics.MultiPointCrossover
Create a new crossover instance with two crossover points and crossover probability 0.05.
mutate(MSeq<G>, double) - Method in class org.jenetics.GaussianMutator
 
mutate(MSeq<G>, double) - Method in class org.jenetics.Mutator
Template method which gives an (re)implementation of the mutation class the possibility to perform its own mutation operation, based on a writable gene array and the gene mutation probability p.
mutate(MSeq<G>, double) - Method in class org.jenetics.SwapMutator
Swaps the genes in the given array, with the mutation probability of this mutation.
Mutator<G extends Gene<?,G>> - Class in org.jenetics
This class is for mutating a chromosomes of an given population.
Mutator(double) - Constructor for class org.jenetics.Mutator
Construct a Mutation object which a given mutation probability.
Mutator() - Constructor for class org.jenetics.Mutator
Default constructor, with probability = 0.01.

N

newArray(int) - Static method in class org.jenetics.util.bit
Create a new byte[] array which can store at least the number of bits as defined by the given length parameter.
newArray(int, double) - Static method in class org.jenetics.util.bit
Create a new byte[] array which can store at least the number of bits as defined by the given length parameter.
newInstance(ISeq<BitGene>) - Method in class org.jenetics.BitChromosome
 
newInstance() - Method in class org.jenetics.BitChromosome
 
newInstance() - Method in enum org.jenetics.BitGene
Create a new, random gene.
newInstance(Boolean) - Method in enum org.jenetics.BitGene
Create a new gene from the given value..
newInstance(A) - Method in interface org.jenetics.BoundedGene
Create a new gene from the given value and the current bounds.
newInstance(ISeq<CharacterGene>) - Method in class org.jenetics.CharacterChromosome
 
newInstance() - Method in class org.jenetics.CharacterChromosome
Create a new, random chromosome.
newInstance() - Method in class org.jenetics.CharacterGene
 
newInstance(Character) - Method in class org.jenetics.CharacterGene
Create a new character gene from the given character.
newInstance(ISeq<G>) - Method in interface org.jenetics.Chromosome
A factory method which creates a new Chromosome of specific type and the given genes.
newInstance(ISeq<DoubleGene>) - Method in class org.jenetics.DoubleChromosome
 
newInstance() - Method in class org.jenetics.DoubleChromosome
 
newInstance(Number) - Method in class org.jenetics.DoubleGene
 
newInstance() - Method in class org.jenetics.DoubleGene
 
newInstance() - Method in class org.jenetics.EnumGene
 
newInstance(A) - Method in class org.jenetics.EnumGene
Create a new gene from the given value and the gene context.
newInstance() - Method in interface org.jenetics.Gene
Return a new, random gene of the same type than this gene.
newInstance(A) - Method in interface org.jenetics.Gene
Create a new gene from the given value and the gene context.
newInstance() - Method in class org.jenetics.Genotype
Return a new, random genotype by creating new, random chromosomes (calling the Factory.newInstance() method) from the chromosomes of this genotype.
newInstance(ISeq<IntegerGene>) - Method in class org.jenetics.IntegerChromosome
 
newInstance() - Method in class org.jenetics.IntegerChromosome
 
newInstance(Number) - Method in class org.jenetics.IntegerGene
 
newInstance() - Method in class org.jenetics.IntegerGene
 
newInstance(ISeq<LongGene>) - Method in class org.jenetics.LongChromosome
 
newInstance() - Method in class org.jenetics.LongChromosome
 
newInstance(Number) - Method in class org.jenetics.LongGene
 
newInstance() - Method in class org.jenetics.LongGene
 
newInstance(Number) - Method in interface org.jenetics.NumericGene
 
newInstance() - Method in class org.jenetics.PermutationChromosome
Create a new, random chromosome.
newInstance(ISeq<EnumGene<T>>) - Method in class org.jenetics.PermutationChromosome
 
newInstance(Function<? super Genotype<G>, ? extends C>, Function<? super C, ? extends C>, int) - Method in class org.jenetics.Phenotype
Return a new phenotype with the the genotype of this and with new fitness function, fitness scaler and generation.
newInstance(Function<? super Genotype<G>, ? extends C>, int) - Method in class org.jenetics.Phenotype
Return a new phenotype with the the genotype of this and with new fitness function and generation.
newInstance() - Method in interface org.jenetics.util.Factory
Create a new instance of type T.
next() - Method in class org.jenetics.util.IndexStream
Return the next (positive inclusive zero) index, or -1 if the stream has reached its end.
next(int) - Method in class org.jenetics.util.Random64
 
nextBoolean() - Method in class org.jenetics.util.Random64
 
nextBytes(byte[]) - Method in class org.jenetics.util.Random64
Optimized version of the Random.nextBytes(byte[]) method for 64-bit random engines.
nextDouble(Random, double, double) - Static method in class org.jenetics.util.math.random
Returns a pseudo-random, uniformly distributed double value between min (inclusively) and max (exclusively).
nextDouble() - Method in class org.jenetics.util.Random64
Optimized version of the Random.nextDouble() method for 64-bit random engines.
nextFloat(Random, float, float) - Static method in class org.jenetics.util.math.random
Returns a pseudo-random, uniformly distributed double value between min (inclusively) and max (exclusively).
nextFloat() - Method in class org.jenetics.util.Random64
 
nextInt(Random, int, int) - Static method in class org.jenetics.util.math.random
Returns a pseudo-random, uniformly distributed int value between min and max (min and max included).
nextInt() - Method in class org.jenetics.util.Random64
 
nextLong() - Method in class org.jenetics.util.LCG64ShiftRandom
 
nextLong() - Method in class org.jenetics.util.LCG64ShiftRandom.ThreadSafe
 
nextLong(Random, long, long) - Static method in class org.jenetics.util.math.random
Returns a pseudo-random, uniformly distributed int value between min and max (min and max included).
nextLong(Random, long) - Static method in class org.jenetics.util.math.random
Returns a pseudo-random, uniformly distributed int value between 0 (inclusive) and the specified value (exclusive), drawn from the given random number generator's sequence.
nextLong() - Method in class org.jenetics.util.Random64
Force to explicitly override the Random.nextLong() method.
NormalDistribution<N extends Number & Comparable<? super N>> - Class in org.jenetics.stat
Normal (Gaussian) distribution.
NormalDistribution(Range<N>, double, double) - Constructor for class org.jenetics.stat.NormalDistribution
Create a new normal distribution object.
normalize(double[]) - Static method in class org.jenetics.util.math
Normalize the given double array, so that it sum to one.
not(Function<? super T, Boolean>) - Static method in class org.jenetics.util.functions
Return a predicate which negates the return value of the given predicate.
Null() - Static method in class org.jenetics.AbstractAlterer
Return an alterer which does nothing.
NULL - Static variable in class org.jenetics.util.accumulators
 
Null - Static variable in class org.jenetics.util.functions
A predicate which return true if an given value is null.
NumberStatistics<G extends Gene<?,G>,R extends Number & Comparable<? super R>> - Class in org.jenetics
 
NumberStatistics(Optimize, int, Phenotype<G, R>, Phenotype<G, R>, double, double, int, double, double, double, int, int) - Constructor for class org.jenetics.NumberStatistics
 
NumberStatistics.Builder<G extends Gene<?,G>,R extends Number & Comparable<? super R>> - Class in org.jenetics
Builder for the NumberStatistics class.
NumberStatistics.Builder() - Constructor for class org.jenetics.NumberStatistics.Builder
Create a new NumberStatistics builder.
NumberStatistics.Calculator<G extends Gene<?,G>,R extends Number & Comparable<? super R>> - Class in org.jenetics
 
NumberStatistics.Calculator() - Constructor for class org.jenetics.NumberStatistics.Calculator
 
NumericChromosome<N extends Number & Comparable<? super N>,G extends NumericGene<N,G>> - Interface in org.jenetics
Numeric chromosome interface.
NumericGene<N extends Number & Comparable<? super N>,G extends NumericGene<N,G>> - Interface in org.jenetics
Base interface for numeric genes.

O

object - Static variable in class org.jenetics.util.IO
IO implementation for "native" Java serialization.
ObjectToString - Static variable in class org.jenetics.util.functions
Convert an object to a string by calling the objects Object.toString() method.
of(int, double) - Static method in class org.jenetics.BitChromosome
Construct a new BitChromosome with the given _length.
of(int) - Static method in class org.jenetics.BitChromosome
Constructing a new BitChromosome with the given _length.
of(BitSet, int) - Static method in class org.jenetics.BitChromosome
 
of(BitSet) - Static method in class org.jenetics.BitChromosome
Constructing a new BitChromosome from a given BitSet.
of(BigInteger) - Static method in class org.jenetics.BitChromosome
Create a new BitChromosome from the given big integer value.
of(CharSequence) - Static method in class org.jenetics.BitChromosome
Create a new BitChromosome from the given character sequence containing '0' and '1'; as created with the BitChromosome.toCanonicalString() method.
of(boolean) - Static method in enum org.jenetics.BitGene
Return the corresponding BitGene for the given boolean value.
of(int) - Static method in class org.jenetics.CharacterChromosome
Create a new chromosome with the CharacterGene.DEFAULT_CHARACTERS char set as valid characters.
of(String, CharSeq) - Static method in class org.jenetics.CharacterChromosome
Create a new chromosome from the given genes (given as string).
of(String) - Static method in class org.jenetics.CharacterChromosome
Create a new chromosome from the given genes (given as string).
of(CharSeq) - Static method in class org.jenetics.CharacterGene
Create a new CharacterGene with a randomly chosen character from the set of valid characters.
of(Character) - Static method in class org.jenetics.CharacterGene
Create a new character gene from the given character.
of() - Static method in class org.jenetics.CharacterGene
Create a new random character gene, chosen from the CharacterGene.DEFAULT_CHARACTERS.
of(char, CharSeq) - Static method in class org.jenetics.CharacterGene
Create a new CharacterGene from the give character.
of(Alterer<G>...) - Static method in class org.jenetics.CompositeAlterer
Combine the given alterers.
of(DoubleGene...) - Static method in class org.jenetics.DoubleChromosome
Create a new DoubleChromosome with the given genes.
of(double, double, int) - Static method in class org.jenetics.DoubleChromosome
Create a new random DoubleChromosome.
of(double, double) - Static method in class org.jenetics.DoubleChromosome
Create a new random DoubleChromosome of length one.
of(double, double, double) - Static method in class org.jenetics.DoubleGene
Create a new random DoubleGene with the given value and the given range.
of(double, double) - Static method in class org.jenetics.DoubleGene
Create a new random DoubleGene.
of(ISeq<? extends A>) - Static method in class org.jenetics.EnumGene
Return a new enum gene with an allele randomly chosen from the given valid alleles.
of(int, A...) - Static method in class org.jenetics.EnumGene
Create a new enum gene from the given valid genes and the chosen allele index.
of(A...) - Static method in class org.jenetics.EnumGene
Return a new enum gene with an allele randomly chosen from the given valid alleles.
of(Chromosome<G>...) - Static method in class org.jenetics.Genotype
Create a new Genotype from a given array of Chromosomes.
of(IntegerGene...) - Static method in class org.jenetics.IntegerChromosome
Create a new IntegerChromosome with the given genes.
of(int, int, int) - Static method in class org.jenetics.IntegerChromosome
Create a new random IntegerChromosome.
of(int, int) - Static method in class org.jenetics.IntegerChromosome
Create a new random IntegerChromosome of length one.
of(int, int, int) - Static method in class org.jenetics.IntegerGene
Create a new random IntegerGene with the given value and the given range.
of(int, int) - Static method in class org.jenetics.IntegerGene
Create a new random IntegerGene.
of(LongGene...) - Static method in class org.jenetics.LongChromosome
Create a new LongChromosome with the given genes.
of(long, long, int) - Static method in class org.jenetics.LongChromosome
Create a new random LongChromosome.
of(long, long) - Static method in class org.jenetics.LongChromosome
Create a new random LongChromosome of length one.
of(long, long, long) - Static method in class org.jenetics.LongGene
Create a new random LongGene with the given value and the given range.
of(long, long) - Static method in class org.jenetics.LongGene
Create a new random LongGene.
of(ISeq<? extends T>) - Static method in class org.jenetics.PermutationChromosome
Create a new, random chromosome with the given valid alleles.
of(T...) - Static method in class org.jenetics.PermutationChromosome
Create a new, random chromosome with the given valid alleles.
of(Genotype<G>, Function<? super Genotype<G>, C>, int) - Static method in class org.jenetics.Phenotype
The Genotype is copied to guarantee an immutable class.
of(Genotype<G>, Function<? super Genotype<G>, ? extends C>, Function<? super C, ? extends C>, int) - Static method in class org.jenetics.Phenotype
Create a new phenotype from the given arguments.
of(C...) - Static method in class org.jenetics.stat.Histogram
Create a new Histogram with the given class separators.
of(Double, Double, int) - Static method in class org.jenetics.stat.Histogram
Return a histogram for Double values.
of(Long, Long, int) - Static method in class org.jenetics.stat.Histogram
Return a histogram for Long values.
of(T...) - Static method in class org.jenetics.util.Array
Create a new array from the given values.
of(Collection<? extends T>) - Static method in class org.jenetics.util.Array
Create a new Array from the values of the given Collection.
of(Seq<T>) - Static method in class org.jenetics.util.Array
Create a new Array from the values of the given Seq.
of(CharSequence) - Static method in class org.jenetics.util.CharSeq
Expands the character range for the given pattern.
of(char, char) - Static method in class org.jenetics.util.CharSeq
Expands the characters between a and b.
ofInteger(int) - Static method in class org.jenetics.PermutationChromosome
Create a integer permutation chromosome with the given length.
ofInteger(int, int) - Static method in class org.jenetics.PermutationChromosome
Create a integer permutation chromosome with the given length.
ofMillis(long) - Static method in class org.jenetics.util.Duration
Create a new duration object from the given milli seconds.
ofNanos(long) - Static method in class org.jenetics.util.Duration
Create a new duration object from the given nano seconds.
ofSeconds(double) - Static method in class org.jenetics.util.Duration
Create a new duration object from the given seconds.
ONE - Static variable in enum org.jenetics.BitGene
 
Optimize - Enum in org.jenetics
This enum determines whether the GA should maximize or minimize the fitness function.
optimize(Optimize) - Method in class org.jenetics.Statistics.Builder
 
or(Function<? super T, Boolean>, Function<? super T, Boolean>) - Static method in class org.jenetics.util.functions
Return a or combination of the given predicates.
org.jenetics - package org.jenetics
Introduction
org.jenetics.stat - package org.jenetics.stat
Provides statistics helper classes.
org.jenetics.util - package org.jenetics.util
Provides helper classes.

P

PartiallyMatchedCrossover<T> - Class in org.jenetics
The PartiallyMatchedCrossover (PMX) guarantees that all Genes are found exactly once in each chromosome.
PartiallyMatchedCrossover(double) - Constructor for class org.jenetics.PartiallyMatchedCrossover
 
partition(int, int) - Static method in class org.jenetics.util.arrays
Return a array with the indexes of the partitions of an array with the given size.
PermutationChromosome<T> - Class in org.jenetics
The mutable methods of the AbstractChromosome has been overridden so that no invalid permutation will be created.
PermutationChromosome(ISeq<EnumGene<T>>) - Constructor for class org.jenetics.PermutationChromosome
 
Phenotype<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
The Phenotype consists of a Genotype plus a fitness Function, where the fitness Function represents the environment where the Genotype lives.
Phenotype(Genotype<G>, Function<? super Genotype<G>, ? extends C>, Function<? super C, ? extends C>, int) - Constructor for class org.jenetics.Phenotype
Create a new phenotype from the given arguments.
plus(Histogram<C>) - Method in class org.jenetics.stat.Histogram
Add the given histogram to this in a newly created one.
plus(long, long) - Static method in class org.jenetics.util.math
Add to long values and throws an ArithmeticException in the case of an overflow.
Population<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
A population is a collection of Phenotypes.
Population(Collection<Phenotype<G, C>>) - Constructor for class org.jenetics.Population
Constructs a population containing the elements of the specified collection, in the order they are returned by the collection's iterator.
Population(int) - Constructor for class org.jenetics.Population
Creating a new Population with the pre-allocated population size.
Population() - Constructor for class org.jenetics.Population
Creating a new Population.
pow(long, long) - Static method in class org.jenetics.util.math
Binary exponentiation algorithm.
print(A) - Method in class org.jenetics.stat.Histogram
 
probabilities(Population<G, N>, int) - Method in class org.jenetics.BoltzmannSelector
 
probabilities(Population<G, C>, int) - Method in class org.jenetics.ExponentialRankSelector
This method sorts the population in descending order while calculating the selection probabilities.
probabilities(Population<G, C>, int) - Method in class org.jenetics.LinearRankSelector
This method sorts the population in descending order while calculating the selection probabilities.
probabilities(Population<G, C>, int, Optimize) - Method in class org.jenetics.ProbabilitySelector
This method takes the probabilities from the ProbabilitySelector.probabilities(Population, int) method and inverts it if needed.
probabilities(Population<G, C>, int) - Method in class org.jenetics.ProbabilitySelector
Return an Probability array, which corresponds to the given Population.
probabilities(Population<G, N>, int) - Method in class org.jenetics.RouletteWheelSelector
 
probabilities(Population<G, N>, int) - Method in class org.jenetics.StochasticUniversalSelector
 
ProbabilitySelector<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
Probability selectors are a variation of fitness proportional selectors and selects individuals from a given population based on it's selection probability P(i).
ProbabilitySelector(boolean) - Constructor for class org.jenetics.ProbabilitySelector
Create a new ProbabilitySelector with the given sorting flag.
ProbabilitySelector() - Constructor for class org.jenetics.ProbabilitySelector
Create a new selector with sorted = false.

Q

Quantile<N extends Number> - Class in org.jenetics.stat
Implementation of the quantile estimation algorithm published by
Quantile(double) - Constructor for class org.jenetics.stat.Quantile
Create a new quantile accumulator with the given value.

R

Random(int, double) - Static method in class org.jenetics.util.IndexStream
Create a new random IndexIterator.
Random(int, double, Random) - Static method in class org.jenetics.util.IndexStream
Create a new random IndexIterator.
Random64 - Class in org.jenetics.util
An abstract base class which eases the implementation of Random objects which natively creates random long values.
Random64(long) - Constructor for class org.jenetics.util.Random64
 
Random64() - Constructor for class org.jenetics.util.Random64
 
RandomRegistry - Class in org.jenetics.util
This class holds the Random engine used for the GA.
Range<C extends Comparable<? super C>> - Class in org.jenetics.util
 
Range(C, C) - Constructor for class org.jenetics.util.Range
Create a new range object.
RawFitness() - Static method in class org.jenetics.Phenotype
Create a Function which return the phenotype raw fitness when calling converter.convert(phenotype).
read(Class<T>, String) - Method in class org.jenetics.util.IO
Reads an object from the given file.
read(String) - Method in class org.jenetics.util.IO
Reads an object from the given file.
read(Class<T>, Path) - Method in class org.jenetics.util.IO
Reads an object from the given file.
read(Path) - Method in class org.jenetics.util.IO
Reads an object from the given file.
read(Class<T>, File) - Method in class org.jenetics.util.IO
Reads an object from the given file.
read(File) - Method in class org.jenetics.util.IO
Reads an object from the given file.
read(Class<T>, InputStream) - Method in class org.jenetics.util.IO
Reads an object from the given input stream.
read(InputStream) - Method in class org.jenetics.util.IO
Reads an object from the given input stream.
Recombinator<G extends Gene<?,G>> - Class in org.jenetics
An enhanced genetic algorithm (EGA) combine elements of existing solutions in order to create a new solution, with some of the properties of each parent.
Recombinator(double, int) - Constructor for class org.jenetics.Recombinator
Constructs an alterer with a given recombination probability.
recombine(Population<G, C>, int[], int) - Method in class org.jenetics.Crossover
 
recombine(Population<G, C>, int[], int) - Method in class org.jenetics.MeanAlterer
 
recombine(Population<G, C>, int[], int) - Method in class org.jenetics.Recombinator
Recombination template method.
remove(Phenotype<G, C>) - Method in class org.jenetics.Population
 
remove(Object) - Method in class org.jenetics.Population
 
remove(int) - Method in class org.jenetics.Population
 
removeAll(Collection<?>) - Method in class org.jenetics.Population
 
reset() - Method in class org.jenetics.stat.Quantile
Reset this object to its initial state.
reset() - Method in class org.jenetics.util.LCG64ShiftRandom
Resets the PRNG back to the creation state.
reset() - Method in class org.jenetics.util.LCG64ShiftRandom.ThreadSafe
 
reset() - Static method in class org.jenetics.util.RandomRegistry
Set the random object to it's default value.
reset() - Method in class org.jenetics.util.Timer
Reset the timer.
retainAll(Collection<?>) - Method in class org.jenetics.Population
 
reverse() - Method in class org.jenetics.Population
Reverse the order of the population.
reverse() - Method in class org.jenetics.util.Array
Reverses the given array in place.
reverse(int, int) - Method in class org.jenetics.util.Array
Reverses the part of the array determined by the to indexes.
revert(double[]) - Static method in class org.jenetics.ProbabilitySelector
 
RouletteWheelSelector<G extends Gene<?,G>,N extends Number & Comparable<? super N>> - Class in org.jenetics
The roulette-wheel selector is also known as fitness proportional selector, but in the Jenetics library it is implemented as probability selector.
RouletteWheelSelector() - Constructor for class org.jenetics.RouletteWheelSelector
 
run() - Method in class org.jenetics.Phenotype
This method simply calls the Phenotype.evaluate() method.

S

samples(int) - Method in class org.jenetics.Statistics.Builder
 
scope(R) - Static method in class org.jenetics.util.RandomRegistry
Opens a new Scope with the given random engine.
scope(ThreadLocal<R>) - Static method in class org.jenetics.util.RandomRegistry
Opens a new Scope with the given random engine.
Scoped<T> - Interface in org.jenetics.util
Defines a local scope, where the containing value is valid.
seed(byte[]) - Static method in class org.jenetics.util.math.random
Fills the given byte array with random bytes, created by successive calls of the math.random.seed() method.
seed() - Static method in class org.jenetics.util.math.random
Calculating a 64 bit seed value which can be used for initializing PRNGs.
seed(long) - Static method in class org.jenetics.util.math.random
Uses the given base value to create a reasonable safe seed value.
seedBytes(int) - Static method in class org.jenetics.util.math.random
Create a new seed byte array of the given length.
select(Population<G, C>, int, Optimize) - Method in class org.jenetics.MonteCarloSelector
 
select(Population<G, C>, int, Optimize) - Method in class org.jenetics.ProbabilitySelector
 
select(Population<G, C>, int, Optimize) - Method in interface org.jenetics.Selector
Select phenotypes from the Population.
select(Population<G, N>, int, Optimize) - Method in class org.jenetics.StochasticUniversalSelector
This method sorts the population in descending order while calculating the selection probabilities.
select(Population<G, C>, int, Optimize) - Method in class org.jenetics.TournamentSelector
 
select(Population<G, C>, int, Optimize) - Method in class org.jenetics.TruncationSelector
This method sorts the population in descending order while calculating the selection probabilities.
selection - Variable in class org.jenetics.Statistics.Time
The selection time.
Selector<G extends Gene<?,G>,C extends Comparable<? super C>> - Interface in org.jenetics
Selectors are responsible for selecting a given number of individuals from the population.
Seq<T> - Interface in org.jenetics.util
General interface for a ordered, fixed sized, object sequence.
set(int, Phenotype<G, C>) - Method in class org.jenetics.Population
 
set(int, T) - Method in class org.jenetics.util.Array
 
set(byte[], int, boolean) - Static method in class org.jenetics.util.bit
Set the bit in the given byte array at the bit position (not the index within the byte array) to the specified value.
set(byte[], int) - Static method in class org.jenetics.util.bit
Set the bit in the given byte array at the bit position (not the index within the byte array) to true.
set(T) - Method in class org.jenetics.util.FinalReference
Set the reference value.
set(int, T) - Method in interface org.jenetics.util.MSeq
Set the value at the given index.
setAccumulator(Accumulator<? super Long>) - Method in class org.jenetics.util.Timer
Set the accumulator for the interim results.
setAll(T) - Method in class org.jenetics.util.Array
 
setAll(Iterator<? extends T>) - Method in class org.jenetics.util.Array
 
setAll(Iterable<? extends T>) - Method in class org.jenetics.util.Array
 
setAll(T[]) - Method in class org.jenetics.util.Array
 
setAll(T) - Method in interface org.jenetics.util.MSeq
Set all sequence elements to the given value.
setAll(Iterator<? extends T>) - Method in interface org.jenetics.util.MSeq
Fills the sequence with values of the given iterator.
setAll(Iterable<? extends T>) - Method in interface org.jenetics.util.MSeq
Fills the sequence with values of the given iterable.
setAll(T[]) - Method in interface org.jenetics.util.MSeq
Fill the sequence with the given values.
setAlterer(Alterer<G>) - Method in class org.jenetics.GeneticAlgorithm
Set the alterer.
setAlterers(Alterer<G>...) - Method in class org.jenetics.GeneticAlgorithm
Set the given alterers.
setFitnessScaler(Function<? super C, ? extends C>) - Method in class org.jenetics.GeneticAlgorithm
Set the currently used fitness scaler.
setGenotypes(Collection<Genotype<G>>) - Method in class org.jenetics.GeneticAlgorithm
Set/change the population in form of a list of genotypes.
setLabel(String) - Method in class org.jenetics.util.Timer
Set the timer label.
setMaximalPhenotypeAge(int) - Method in class org.jenetics.GeneticAlgorithm
Set the maximum age of the phenotypes in the population.
setOffspringFraction(double) - Method in class org.jenetics.GeneticAlgorithm
Set the offspring fraction.
setOffspringSelector(Selector<G, C>) - Method in class org.jenetics.GeneticAlgorithm
Set the offspring selector.
setPopulation(Collection<Phenotype<G, C>>) - Method in class org.jenetics.GeneticAlgorithm
Set the (initial) population in form of a list of phenotypes.
setPopulationSize(int) - Method in class org.jenetics.GeneticAlgorithm
Set the desired population size.
setRandom(Random) - Static method in class org.jenetics.util.RandomRegistry
Set the new global Random object for the GA.
setRandom(ThreadLocal<? extends Random>) - Static method in class org.jenetics.util.RandomRegistry
Set the new global Random object for the GA.
setSeed(long) - Method in class org.jenetics.util.LCG64ShiftRandom
 
setSeed(long) - Method in class org.jenetics.util.LCG64ShiftRandom.ThreadSafe
 
setSelectors(Selector<G, C>) - Method in class org.jenetics.GeneticAlgorithm
Set both, the offspring selector and the survivor selector.
setStatisticsCalculator(Statistics.Calculator<G, C>) - Method in class org.jenetics.GeneticAlgorithm
Set the statistic calculator for this genetic algorithm instance.
setSurvivorSelector(Selector<G, C>) - Method in class org.jenetics.GeneticAlgorithm
Set the survivor selector.
setup() - Method in class org.jenetics.GeneticAlgorithm
Create the initial population of the GA.
setup(Collection<Genotype<G>>) - Method in class org.jenetics.GeneticAlgorithm
Setting up the GeneticAlgorithm with the given initial population.
shiftLeft(byte[], int) - Static method in class org.jenetics.util.bit
Shifting all bits in the given data array the given shift to the left.
shiftRight(byte[], int) - Static method in class org.jenetics.util.bit
Shifting all bits in the given data array the given shift to the right.
shortValue(int) - Method in interface org.jenetics.NumericChromosome
Return the short value of this NumericChromosome at the given index.
shortValue() - Method in interface org.jenetics.NumericChromosome
Return the short value of this NumericChromosome at the index 0.
shortValue() - Method in interface org.jenetics.NumericGene
Returns the value of the specified gene as an short.
shuffle(Random) - Method in class org.jenetics.util.Array
Randomize this array using the given Random object.
shuffle() - Method in class org.jenetics.util.Array
Randomize this array using the registered Random object.
SinglePointCrossover<G extends Gene<?,G>> - Class in org.jenetics
Single point crossover
SinglePointCrossover(double) - Constructor for class org.jenetics.SinglePointCrossover
Constructs an alterer with a given recombination probability.
SinglePointCrossover() - Constructor for class org.jenetics.SinglePointCrossover
Create a new single point crossover object with crossover probability of 0.05.
size() - Method in class org.jenetics.Population
 
sort() - Method in class org.jenetics.Population
Sorting the phenotypes in this population according to its fitness value in descending order.
sort() - Method in class org.jenetics.util.Array
Sorts the array of objects into ascending order, according to the natural ordering of its elements.
sort(int, int) - Method in class org.jenetics.util.Array
Sorts the array of objects into ascending order, according to the natural ordering of its elements.
sort(Comparator<? super T>) - Method in class org.jenetics.util.Array
Sorts the array of objects according to the order induced by the specified comparator.
sort(int, int, Comparator<? super T>) - Method in class org.jenetics.util.Array
Sorts the array of objects according to the order induced by the specified comparator.
sort(MSeq<T>) - Static method in class org.jenetics.util.arrays
Calls the sort method on the Arrays class.
sortWith(Comparator<? super C>) - Method in class org.jenetics.Population
Sort this population according the order defined by the given comparator.
split(int, int) - Method in class org.jenetics.util.LCG64ShiftRandom
Changes the internal state of the PRNG in a way that future calls to LCG64ShiftRandom.nextLong() will generated the sth sub-stream of pth sub-streams.
split(int, int) - Method in class org.jenetics.util.LCG64ShiftRandom.ThreadSafe
 
SQR_SCALER - Static variable in class org.jenetics.ExponentialScaler
 
SQRT_SCALER - Static variable in class org.jenetics.ExponentialScaler
 
standardError(double) - Method in class org.jenetics.NumberStatistics.Builder
 
start() - Method in class org.jenetics.util.Timer
Start the timer.
StaticObject - Class in org.jenetics.util
This class is used to tag a class as object with static methods only.
StaticObject() - Constructor for class org.jenetics.util.StaticObject
Calling the constructor of an StaticObject will always throw an AssertionError.
statistics(Statistics<G, R>) - Method in class org.jenetics.NumberStatistics.Builder
 
statistics(NumberStatistics<G, R>) - Method in class org.jenetics.NumberStatistics.Builder
Set the values of this builder with the values of the given statistics.
Statistics<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
Data object which holds performance indicators of a given Population.
Statistics(Optimize, int, Phenotype<G, C>, Phenotype<G, C>, int, double, double, int, int) - Constructor for class org.jenetics.Statistics
Evaluates statistic values from a given population.
statistics(Statistics<G, C>) - Method in class org.jenetics.Statistics.Builder
Set the values of this builder with the values of the given statistics.
statistics - Variable in class org.jenetics.Statistics.Time
The statistics time.
Statistics.Builder<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
Builder for the Statistics class.
Statistics.Builder() - Constructor for class org.jenetics.Statistics.Builder
Create a new Statistics builder.
Statistics.Calculator<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
Class for calculating the statistics.
Statistics.Calculator() - Constructor for class org.jenetics.Statistics.Calculator
Create a new calculator object.
Statistics.Time - Class in org.jenetics
Class which holds time statistic values.
Statistics.Time() - Constructor for class org.jenetics.Statistics.Time
Create a new time object with zero time values.
SteadyFitness(int) - Static method in class org.jenetics.termination
Create a terminator which returns false if the fitness hasn't improved for a given number of generations.
StochasticUniversalSelector<G extends Gene<?,G>,N extends Number & Comparable<? super N>> - Class in org.jenetics
StochasticUniversalSelector is a method for selecting a population according to some given probability in a way that minimize chance fluctuations.
StochasticUniversalSelector() - Constructor for class org.jenetics.StochasticUniversalSelector
 
stop() - Method in class org.jenetics.util.Timer
Stop the timer.
StringLength - Static variable in class org.jenetics.util.functions
Convert a string value to its length.
StringToDouble - Static variable in class org.jenetics.util.functions
Convert a string to a double.
StringToFloat - Static variable in class org.jenetics.util.functions
Convert a string to a float.
StringToInteger - Static variable in class org.jenetics.util.functions
Convert a string to an integer.
StringToLong - Static variable in class org.jenetics.util.functions
Convert a string to a long.
subList(int, int) - Method in class org.jenetics.Population
 
subSeq(int, int) - Method in class org.jenetics.util.Array
 
subSeq(int) - Method in class org.jenetics.util.Array
 
subSeq(int, int) - Method in interface org.jenetics.util.ISeq
 
subSeq(int) - Method in interface org.jenetics.util.ISeq
 
subSeq(int, int) - Method in interface org.jenetics.util.MSeq
 
subSeq(int) - Method in interface org.jenetics.util.MSeq
 
subSeq(int) - Method in interface org.jenetics.util.Seq
Returns a view of the portion of this sequence between the specified start, inclusive, and end, exclusive.
subSeq(int, int) - Method in interface org.jenetics.util.Seq
Returns a view of the portion of this sequence between the specified start, inclusive, and end, exclusive.
subSequence(int, int) - Method in class org.jenetics.CharacterChromosome
 
subSequence(int, int) - Method in class org.jenetics.util.CharSeq
 
subset(int, int) - Static method in class org.jenetics.util.math
Selects a random subset of size k from a set of size n.
subset(int, int, Random) - Static method in class org.jenetics.util.math
Selects a random subset of size k from a set of size n.
subset(int, int[]) - Static method in class org.jenetics.util.math
Selects a random subset of size sub.length from a set of size n.
subset(int, int[], Random) - Static method in class org.jenetics.util.math
Selects a random subset of size sub.length from a set of size n.
sum(double[]) - Static method in class org.jenetics.util.math.statistics
Implementation of the Kahan summation algorithm.
sum(long[]) - Static method in class org.jenetics.util.math.statistics
Add the values of the given array.
swap(double[], int, int) - Static method in class org.jenetics.ProbabilitySelector
 
swap(int, int) - Method in class org.jenetics.util.Array
 
swap(int, int, MSeq<T>, int) - Method in class org.jenetics.util.Array
 
swap(int, int, Array<T>, int) - Method in class org.jenetics.util.Array
 
swap(byte[], int, int, byte[], int) - Static method in class org.jenetics.util.bit
Swap a given range with a range of the same size with another array.
swap(int, int) - Method in interface org.jenetics.util.MSeq
Swap the elements at the two positions.
swap(int, int, MSeq<T>, int) - Method in interface org.jenetics.util.MSeq
Swap a given range with a range of the same size with another array.
SwapMutator<G extends Gene<?,G>> - Class in org.jenetics
The SwapMutation changes the order of genes in a chromosome, with the hope of bringing related genes closer together, thereby facilitating the production of building blocks.
SwapMutator(double) - Constructor for class org.jenetics.SwapMutator
Constructs an alterer with a given recombination probability.
SwapMutator() - Constructor for class org.jenetics.SwapMutator
Default constructor, with default mutation probability (AbstractAlterer.DEFAULT_ALTER_PROBABILITY).

T

termination - Class in org.jenetics
Some default GA termination strategies.
Timer - Class in org.jenetics.util
Timer for measure the performance of the GA.
Timer(String) - Constructor for class org.jenetics.util.Timer
Create a new time with the given label.
Timer() - Constructor for class org.jenetics.util.Timer
Create a new Timer object.
times(double[], double) - Static method in class org.jenetics.util.math
Component wise multiplication of the given double array.
toArray() - Method in class org.jenetics.Population
 
toArray(A[]) - Method in class org.jenetics.Population
 
toArray() - Method in interface org.jenetics.util.Seq
Return an array containing all of the elements in this sequence in right order.
toArray(T[]) - Method in interface org.jenetics.util.Seq
Return an array containing all of the elements in this sequence in right order; the runtime type of the returned array is that of the specified array.
toBigInteger() - Method in class org.jenetics.BitChromosome
Return the BigInteger value this BitChromosome represents.
toBitSet() - Method in class org.jenetics.BitChromosome
Return the corresponding BitSet of this BitChromosome.
toByteArray(byte[]) - Method in class org.jenetics.BitChromosome
Returns the two's-complement binary representation of this large integer.
toByteArray() - Method in class org.jenetics.BitChromosome
 
toByteLength(int) - Static method in class org.jenetics.util.bit
Return the minimum number of bytes to store the given number of bits.
toByteString(byte...) - Static method in class org.jenetics.util.bit
Convert a binary representation of the given byte array to a string.
toCanonicalString() - Method in class org.jenetics.BitChromosome
Return the BitChromosome as String.
toISeq() - Method in class org.jenetics.util.Array
 
toISeq(CharSequence) - Static method in class org.jenetics.util.CharSeq
Helper method for creating a sequence of characters from the given CharSequence.
toISeq() - Method in interface org.jenetics.util.MSeq
Return a read-only projection of this sequence.
toMillis() - Method in class org.jenetics.util.Duration
Return the amount of this duration in milli seconds.
toNanos() - Method in class org.jenetics.util.Duration
Return the amount of this duration in nano seconds.
toSeconds() - Method in class org.jenetics.util.Duration
Return the amount of this duration in seconds.
toSeq() - Method in class org.jenetics.AbstractChromosome
 
toSeq() - Method in class org.jenetics.BitChromosome
 
toSeq() - Method in interface org.jenetics.Chromosome
Return an unmodifiable sequence of the genes of this chromosome.
toSeq() - Method in class org.jenetics.Genotype
 
toString() - Method in class org.jenetics.AbstractChromosome
 
toString() - Method in class org.jenetics.BitChromosome
 
toString() - Method in enum org.jenetics.BitGene
 
toString() - Method in class org.jenetics.BoltzmannSelector
 
toString() - Method in class org.jenetics.CharacterChromosome
 
toString() - Method in class org.jenetics.CharacterGene
 
toString() - Method in class org.jenetics.CompositeAlterer
 
toString() - Method in class org.jenetics.EnumGene
 
toString() - Method in class org.jenetics.ExponentialRankSelector
 
toString() - Method in class org.jenetics.ExponentialScaler
 
toString() - Method in class org.jenetics.GaussianMutator
 
toString() - Method in class org.jenetics.GeneticAlgorithm
This method acquires the lock to ensure that the returned value is consistent.
toString() - Method in class org.jenetics.Genotype
 
toString() - Method in class org.jenetics.LinearRankSelector
 
toString() - Method in class org.jenetics.MeanAlterer
 
toString() - Method in class org.jenetics.MonteCarloSelector
 
toString() - Method in class org.jenetics.MultiPointCrossover
 
toString() - Method in class org.jenetics.Mutator
 
toString() - Method in class org.jenetics.NumberStatistics
 
toString() - Method in class org.jenetics.PartiallyMatchedCrossover
 
toString() - Method in class org.jenetics.PermutationChromosome
 
toString() - Method in class org.jenetics.Phenotype
 
toString() - Method in class org.jenetics.Population
 
toString() - Method in class org.jenetics.RouletteWheelSelector
 
toString() - Method in class org.jenetics.SinglePointCrossover
 
toString() - Method in class org.jenetics.stat.Histogram
 
toString() - Method in class org.jenetics.stat.LinearDistribution
 
toString() - Method in class org.jenetics.stat.Mean
 
toString() - Method in class org.jenetics.stat.NormalDistribution
 
toString() - Method in class org.jenetics.stat.Quantile
 
toString() - Method in class org.jenetics.stat.UniformDistribution
 
toString() - Method in class org.jenetics.stat.Variance
 
toString() - Method in class org.jenetics.Statistics.Time
 
toString() - Method in class org.jenetics.Statistics
 
toString() - Method in class org.jenetics.StochasticUniversalSelector
 
toString() - Method in class org.jenetics.SwapMutator
 
toString() - Method in class org.jenetics.TournamentSelector
 
toString() - Method in class org.jenetics.TruncationSelector
 
toString() - Method in class org.jenetics.util.accumulators.Max
 
toString() - Method in class org.jenetics.util.accumulators.Min
 
toString() - Method in class org.jenetics.util.accumulators.MinMax
 
toString() - Method in class org.jenetics.util.CharSeq
 
toString() - Method in class org.jenetics.util.Duration
 
toString() - Method in class org.jenetics.util.FinalReference
 
toString() - Method in class org.jenetics.util.LCG64ShiftRandom.Param
 
toString() - Method in class org.jenetics.util.LCG64ShiftRandom
 
toString() - Method in class org.jenetics.util.MappedAccumulator
 
toString(String, String, String) - Method in interface org.jenetics.util.Seq
Create a string representation of the given sequence.
toString(String) - Method in interface org.jenetics.util.Seq
Create a string representation of the given sequence.
toString() - Method in class org.jenetics.util.Timer
 
TournamentSelector<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
In tournament selection the best individual from a random sample of s individuals is chosen from the population Pg.
TournamentSelector(int) - Constructor for class org.jenetics.TournamentSelector
Create a tournament selector with the give sample size.
TournamentSelector() - Constructor for class org.jenetics.TournamentSelector
Create a tournament selector with sample size two.
TruncationSelector<G extends Gene<?,G>,C extends Comparable<? super C>> - Class in org.jenetics
In truncation selection individuals are sorted according to their fitness.
TruncationSelector() - Constructor for class org.jenetics.TruncationSelector
Create a new TruncationSelector object.

U

ulpDistance(double, double) - Static method in class org.jenetics.util.math
Return the ULP distance of the given two double values.
ulpPosition(double) - Static method in class org.jenetics.util.math
Calculating the ULP position of a double number.
unboxBoolean(Array<Boolean>) - Static method in class org.jenetics.util.Array
Unboxes the given array to the corresponding native version.
unboxChar(Array<Character>) - Static method in class org.jenetics.util.Array
Unboxes the given array to the corresponding native version.
unboxDouble(Array<Double>) - Static method in class org.jenetics.util.Array
Unboxes the given array to the corresponding native version.
unboxFloat(Array<Float>) - Static method in class org.jenetics.util.Array
Unboxes the given array to the corresponding native version.
unboxInt(Array<Integer>) - Static method in class org.jenetics.util.Array
Unboxes the given array to the corresponding native version.
unboxLong(Array<Long>) - Static method in class org.jenetics.util.Array
Unboxes the given array to the corresponding native version.
unboxShort(Array<Short>) - Static method in class org.jenetics.util.Array
Unboxes the given array to the corresponding native version.
UniformDistribution<N extends Number & Comparable<? super N>> - Class in org.jenetics.stat
UniformDistribution(Range<N>) - Constructor for class org.jenetics.stat.UniformDistribution
Create a new uniform distribution with the given domain.
UniformDistribution(N, N) - Constructor for class org.jenetics.stat.UniformDistribution
Create a new uniform distribution with the given min and max values.
unset(byte[], int) - Static method in class org.jenetics.util.bit
Set the bit in the given byte array at the bit position (not the index within the byte array) to false.

V

ValidCharacters - Static variable in class org.jenetics.CharacterGene
Converter for accessing the valid characters from a given gene.
valueOf(String) - Static method in enum org.jenetics.BitGene
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum org.jenetics.Optimize
Returns the enum constant of this type with the specified name.
values() - Static method in enum org.jenetics.BitGene
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum org.jenetics.Optimize
Returns an array containing the constants of this enum type, in the order they are declared.
Variance<N extends Number> - Class in org.jenetics.stat
Calculate the variance from a finite sample of N observations.
Variance() - Constructor for class org.jenetics.stat.Variance
 
Verifiable - Interface in org.jenetics.util
 

W

worst(C, C) - Method in enum org.jenetics.Optimize
Return the worst value, according to this optimization direction.
worstPhenotype(Phenotype<G, C>) - Method in class org.jenetics.Statistics.Builder
 
write(Object, String) - Method in class org.jenetics.util.IO
Write the (serializable) object to the given path.
write(Object, Path) - Method in class org.jenetics.util.IO
Write the (serializable) object to the given path.
write(Object, File) - Method in class org.jenetics.util.IO
Write the (serializable) object to the given file.
write(Object, OutputStream) - Method in class org.jenetics.util.IO
Write the (serializable) object to the given output stream.

Z

ZERO - Static variable in enum org.jenetics.BitGene
 

_

_ageMean - Variable in class org.jenetics.Statistics
 
_ageMean - Variable in class org.jenetics.Statistics.Builder
 
_ageVariance - Variable in class org.jenetics.Statistics
 
_ageVariance - Variable in class org.jenetics.Statistics.Builder
 
_best - Variable in class org.jenetics.Statistics
 
_best - Variable in class org.jenetics.Statistics.Builder
 
_fitnessMean - Variable in class org.jenetics.NumberStatistics
 
_fitnessMean - Variable in class org.jenetics.NumberStatistics.Builder
 
_fitnessVariance - Variable in class org.jenetics.NumberStatistics
 
_fitnessVariance - Variable in class org.jenetics.NumberStatistics.Builder
 
_generation - Variable in class org.jenetics.Statistics
 
_generation - Variable in class org.jenetics.Statistics.Builder
 
_genes - Variable in class org.jenetics.AbstractChromosome
Array of genes which forms the chromosome.
_genes - Variable in class org.jenetics.BitChromosome
The boolean array which holds the BitGenes.
_invalid - Variable in class org.jenetics.Statistics
 
_invalid - Variable in class org.jenetics.Statistics.Builder
 
_killed - Variable in class org.jenetics.Statistics
 
_killed - Variable in class org.jenetics.Statistics.Builder
 
_length - Variable in class org.jenetics.BitChromosome
The length of the chromosomes (number of bits).
_mean - Variable in class org.jenetics.stat.Mean
 
_optimize - Variable in class org.jenetics.Statistics
 
_optimize - Variable in class org.jenetics.Statistics.Builder
 
_p - Variable in class org.jenetics.BitChromosome
The one's probability of the randomly generated Chromosome.
_probability - Variable in class org.jenetics.AbstractAlterer
The altering probability.
_samples - Variable in class org.jenetics.Statistics
 
_samples - Variable in class org.jenetics.Statistics.Builder
 
_samples - Variable in class org.jenetics.util.MappedAccumulator
The number of accumulated samples.
_standardError - Variable in class org.jenetics.NumberStatistics
 
_standardError - Variable in class org.jenetics.NumberStatistics.Builder
 
_valid - Variable in class org.jenetics.AbstractChromosome
Indicates whether this chromosome is valid or not.
_worst - Variable in class org.jenetics.Statistics
 
_worst - Variable in class org.jenetics.Statistics.Builder
 

Χ

χ2(Function<C, Double>, C, C) - Method in class org.jenetics.stat.Histogram
Calculate the χ2 value of the current histogram for the assumed Cumulative density function cdf.
χ2(Function<C, Double>) - Method in class org.jenetics.stat.Histogram
Calculate the χ2 value of the current histogram for the assumed Cumulative density function cdf.
A B C D E F G H I J K L M N O P Q R S T U V W Z _ Χ 

© 2007-2014 Franz Wilhelmstötter  (2014-10-03 19:44)