Index
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form
A
- a() - Method in record class io.jenetics.ShiftMutator.Range
-
Returns the value of the
a
record component. - a() - Method in record class io.jenetics.ShuffleMutator.Range
-
Returns the value of the
a
record component. - ABS - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Return the absolute value of a double value.
- AbstractAlterer<G,
C> - Class in io.jenetics -
Abstract implementation of the alterer interface.
- AbstractAlterer(double) - Constructor for class io.jenetics.AbstractAlterer
-
Constructs an alterer with a given recombination probability.
- AbstractChromosome<G> - Class in io.jenetics
-
The abstract base implementation of the Chromosome interface.
- AbstractChromosome(ISeq<? extends G>) - Constructor for class io.jenetics.AbstractChromosome
-
Create a new
AbstractChromosome
from the givengenes
array. - AbstractTreeChromosome<A,
G> - Class in io.jenetics.ext -
Abstract base implementation of a
TreeChromosome
. - AbstractTreeChromosome(ISeq<? extends G>) - Constructor for class io.jenetics.ext.AbstractTreeChromosome
- AbstractTreeGene<A,
G> - Class in io.jenetics.ext -
Abstract implementation of the
TreeGene
interface.. - AbstractTreeGene(A, int, int) - Constructor for class io.jenetics.ext.AbstractTreeGene
-
Creates a new tree-gene from the given data.
- accept(double) - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Records a new value into the moment information
- accept(double) - Method in class io.jenetics.stat.Quantile
- accept(int) - Method in class io.jenetics.stat.IntMomentStatistics
-
Records a new value into the moment information
- accept(int) - Method in class io.jenetics.stat.LongMomentStatistics
-
Records a new value into the moment information
- accept(long) - Method in class io.jenetics.stat.LongMomentStatistics
-
Records a new value into the moment information
- accept(C) - Method in class io.jenetics.stat.MinMax
-
Accept the element for min-max calculation.
- accept(EvolutionResult<?, C>) - Method in class io.jenetics.engine.EvolutionStatistics
- accumulator() - Method in interface io.jenetics.util.Accumulator
- Accumulator<T,
A, - Interface in io.jenetics.utilR> -
This interface lets you accumulate elements of type
T
to a result of typeR
. - ACOS - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the arc cosine of a double value.
- add(Sample<T>) - Method in class io.jenetics.prog.regression.SampleBuffer
-
Adding a new sample point to the buffer.
- add(T) - Method in class io.jenetics.ext.moea.ParetoFront
-
Inserts an
element
to this pareto front. - ADD - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the sum of its arguments.
- addAll(Collection<? extends Sample<? extends T>>) - Method in class io.jenetics.prog.regression.SampleBuffer
-
The given sample points to the buffer.
- addAll(Collection<? extends T>) - Method in class io.jenetics.ext.moea.ParetoFront
-
Adds all elements of the given collection to
this
pareto front. - after(EvolutionResult<G, C>) - Method in interface io.jenetics.engine.EvolutionInterceptor
-
This method is called after the evaluation of a generation.
- age(long) - Method in class io.jenetics.Phenotype
-
Return the age of this phenotype depending on the given current generation.
- ALL - Static variable in record class io.jenetics.ext.util.CsvSupport.ColumnIndexes
-
Indicating that all columns should be part of the split result.
- allele() - Method in class io.jenetics.AnyGene
- allele() - Method in enum class io.jenetics.BitGene
- allele() - Method in class io.jenetics.CharacterGene
- allele() - Method in class io.jenetics.DoubleGene
- allele() - Method in class io.jenetics.EnumGene
- allele() - Method in class io.jenetics.ext.AbstractTreeGene
- allele() - Method in class io.jenetics.ext.BigIntegerGene
- allele() - Method in interface io.jenetics.Gene
-
Return the allele of this gene.
- allele() - Method in class io.jenetics.IntegerGene
- allele() - Method in class io.jenetics.LongGene
- alleleIndex() - Method in class io.jenetics.EnumGene
-
Return the index of the allele this gene is representing.
- alleleReader() - Static method in class io.jenetics.xml.Readers.DoubleChromosome
-
Return the default allele reader for the
DoubleChromosome
. - alleleReader() - Static method in class io.jenetics.xml.Readers.IntegerChromosome
-
Return the default allele reader for the
IntegerChromosome
. - alleleReader() - Static method in class io.jenetics.xml.Readers.LongChromosome
-
Return the default allele reader for the
LongChromosome
. - alleleWriter() - Static method in class io.jenetics.xml.Writers.DoubleChromosome
-
Return the default double allele writer for the
DoubleChromosome
. - alleleWriter() - Static method in class io.jenetics.xml.Writers.IntegerChromosome
-
Return the default integer allele writer for the
IntegerChromosome
. - alleleWriter() - Static method in class io.jenetics.xml.Writers.LongChromosome
-
Return the default long-allele writer for the
IntegerChromosome
. - alter(Seq<Phenotype<G, C>>, long) - Method in interface io.jenetics.Alterer
-
Alters (recombine) a given population.
- alter(Seq<Phenotype<G, C>>, long) - Method in class io.jenetics.ext.WeaselMutator
- alter(Seq<Phenotype<G, C>>, long) - Method in class io.jenetics.Mutator
-
Concrete implementation of the alter method.
- alter(Seq<Phenotype<G, C>>, long) - Method in class io.jenetics.PartialAlterer
- alter(Seq<Phenotype<G, C>>, long) - Method in class io.jenetics.Recombinator
- alterations() - Method in record class io.jenetics.AltererResult
-
Returns the value of the
alterations
record component. - alterCount() - Method in class io.jenetics.engine.EvolutionResult
-
The number of altered individuals.
- alterDuration() - Method in class io.jenetics.engine.EvolutionStatistics
-
Return the duration statistics needed for altering the population, in seconds.
- altered() - Method in class io.jenetics.engine.EvolutionStatistics
-
Return the statistics about the altered individuals during the evolution process.
- alterer() - Method in class io.jenetics.engine.Engine
-
Return the used
Alterer
of the GA. - alterer() - Method in class io.jenetics.engine.Engine.Builder
-
Return the used
Alterer
of the GA. - alterer() - Method in class io.jenetics.engine.EvolutionParams
-
Return the used
Alterer
of the GA. - alterer() - Method in class io.jenetics.engine.EvolutionParams.Builder
-
Return the used
Alterer
of the GA. - Alterer<G,
C> - Interface in io.jenetics -
The Alterer is responsible for the changing/recombining the Population.
- AltererResult<G,
C> - Record Class in io.jenetics -
Represents the result pair of a
Alterer.alter(Seq, long)
call, which consists of the altered population and the number of altered individuals. - AltererResult(ISeq<Phenotype<G, C>>) - Constructor for record class io.jenetics.AltererResult
-
Create a new alter result for the given population with zero alterations.
- AltererResult(ISeq<Phenotype<G, C>>, int) - Constructor for record class io.jenetics.AltererResult
-
Create a new alter result for the given arguments.
- alterers(Alterer<G, C>, Alterer<G, C>...) - Method in class io.jenetics.engine.Engine.Builder
-
The alterers used for alter the offspring population.
- alterers(Alterer<G, C>, Alterer<G, C>...) - Method in class io.jenetics.engine.EvolutionParams.Builder
-
The alterers used for alter the offspring population.
- alternatives() - Method in record class io.jenetics.ext.grammar.Cfg.Rule
-
Returns the value of the
alternatives
record component. - and(BitChromosome) - Method in class io.jenetics.BitChromosome
-
Returns a
BitChromosome
whose value is (this & other
). - AND - Enum constant in enum class io.jenetics.prog.op.BoolOp
-
Conjunction.
- andThen(Alterer<G, C>) - Method in interface io.jenetics.Alterer
-
Returns a composed alterer that applies the
this
alterer to its input, and then applies theafter
alterer to the result. - AnyChromosome<A> - Class in io.jenetics
-
Chromosome
implementation, which allows creating genes without explicit implementing theChromosome
interface. - AnyChromosome(ISeq<AnyGene<A>>, Supplier<? extends A>, Predicate<? super A>, Predicate<? super ISeq<A>>, IntRange) - Constructor for class io.jenetics.AnyChromosome
-
Create a new
AnyChromosome
from the givengenes
array. - AnyGene<A> - Class in io.jenetics
-
Gene
implementation, which allows creating genes without explicit implementing theGene
interface. - append(Tree.Path) - Method in class io.jenetics.ext.util.Tree.Path
-
Appends the given
path
tothis
one. - append(Iterable<? extends T>) - Method in interface io.jenetics.util.ISeq
- append(Iterable<? extends T>) - Method in interface io.jenetics.util.MSeq
- append(Iterable<? extends T>) - Method in interface io.jenetics.util.Seq
-
Return a new
Seq
with the givenvalues
appended. - append(T...) - Method in interface io.jenetics.util.ISeq
- append(T...) - Method in interface io.jenetics.util.MSeq
- append(T...) - Method in interface io.jenetics.util.Seq
-
Return a new
Seq
with the givenvalues
appended. - apply(int) - Method in interface io.jenetics.util.Seq
-
Return the value at the given
index
. - apply(A[]) - Method in class io.jenetics.prog.ProgramChromosome
-
Evaluates the root node of this chromosome.
- apply(A[]) - Method in class io.jenetics.prog.ProgramGene
-
Evaluates this program gene (recursively) with the given variable values.
- apply(Engine.Builder<G, C>) - Method in interface io.jenetics.engine.Engine.Setup
-
Applies
this
setup to the given enginebuilder
. - apply(Engine.Builder<G, C>) - Method in class io.jenetics.ext.MLEvolutionStrategy
- apply(Engine.Builder<G, C>) - Method in class io.jenetics.ext.MpLEvolutionStrategy
- apply(Engine.Builder<G, C>) - Method in class io.jenetics.ext.WeaselProgram
- apply(Tree<? extends Op<T>, ?>) - Method in interface io.jenetics.prog.regression.Complexity
-
Calculates the complexity of the current program (possibly) relative to the actual error value.
- apply(Tree<? extends Op<T>, ?>, T[], T[]) - Method in interface io.jenetics.prog.regression.Error
-
Calculates the overall error of a given program tree.
- apply(Boolean[]) - Method in enum class io.jenetics.prog.op.BoolOp
- apply(Double[]) - Method in class io.jenetics.prog.op.MathExpr
- apply(Double[]) - Method in enum class io.jenetics.prog.op.MathOp
- apply(T[]) - Method in class io.jenetics.prog.op.Program
- apply(T[]) - Method in class io.jenetics.prog.op.Val
-
The apply method will always return the
Val.value()
. - apply(T[]) - Method in class io.jenetics.prog.op.Var
- apply(T[], T[]) - Method in interface io.jenetics.prog.regression.LossFunction
-
Calculates the error between the expected function values and the values calculated by the actual
ProgramGene
. - argAt(int) - Method in interface io.jenetics.prog.regression.Sample
-
Return the argument value with the given
index
. - ARITHMETIC_REWRITER - Static variable in class io.jenetics.prog.op.MathExpr
-
This rewriter implements some common arithmetic identities, in exactly this order.
- arity() - Method in enum class io.jenetics.prog.op.BoolOp
- arity() - Method in enum class io.jenetics.prog.op.MathOp
- arity() - Method in interface io.jenetics.prog.op.Op
-
Return the arity of the operation function.
- arity() - Method in class io.jenetics.prog.op.Program
- arity() - Method in class io.jenetics.prog.op.Val
-
The arity of
Val
objects is always zero. - arity() - Method in class io.jenetics.prog.op.Var
- arity() - Method in interface io.jenetics.prog.regression.Sample
-
Return the dimensionality of the sample point arguments.
- as(Class<C>) - Method in interface io.jenetics.Chromosome
-
Casts this
Chromosome
to an instance of typeC
. - ascending() - Method in enum class io.jenetics.Optimize
-
Create an appropriate comparator of the given optimization strategy.
- ASIN - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the arc sine of a double value.
- asISeq() - Method in interface io.jenetics.util.Seq
-
Return this sequence as
ISeq
instance. - asList() - Method in interface io.jenetics.util.MSeq
- asList() - Method in interface io.jenetics.util.Seq
-
Returns a fixed-size list backed by the specified sequence.
- asMSeq() - Method in interface io.jenetics.util.Seq
-
Return this sequence as
MSeq
instance. - async(Function<? super Genotype<G>, ? extends Future<C>>) - Static method in class io.jenetics.engine.Evaluators
-
Return a new fitness evaluator, which evaluates asynchronous fitness functions.
- async(Function<? super T, ? extends Future<C>>, Codec<T, G>) - Static method in class io.jenetics.engine.Evaluators
-
Return a new fitness evaluator, which evaluates asynchronous fitness functions.
- async(Function<? super T, ? extends Future<C>>, Function<? super Genotype<G>, ? extends T>) - Static method in class io.jenetics.engine.Evaluators
-
Return a new fitness evaluator, which evaluates asynchronous fitness functions.
- ATAN - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the arc tangent of a value.
- attach(TreeNode<T>) - Method in class io.jenetics.ext.util.TreeNode
-
Remove the given
child
from its parent and makes it a child of this node by adding it to the end of this node's child array. - attach(Stream<? extends T>) - Method in class io.jenetics.util.StreamPublisher
-
Attaches the given stream to the publisher.
- attach(T) - Method in class io.jenetics.ext.util.TreeNode
-
Attaches the given
child
tothis
node. - attach(T...) - Method in class io.jenetics.ext.util.TreeNode
-
Attaches the given
children
tothis
node. - attr(String) - Static method in class io.jenetics.xml.stream.Reader
-
Return a
Reader
for reading an attribute of an element. - attr(String) - Static method in interface io.jenetics.xml.stream.Writer
-
Writes the attribute with the given
name
to the current outer element. - attr(String, Object) - Static method in interface io.jenetics.xml.stream.Writer
-
Writes the attribute with the given
name
and a constantvalue
to the current outer element. - AutoCloseableXMLStreamReader - Interface in io.jenetics.xml.stream
-
Makes the
XMLStreamReader
interfaceAutoCloseable
. - AutoCloseableXMLStreamWriter - Interface in io.jenetics.xml.stream
-
Makes the
XMLStreamWriter
interfaceAutoCloseable
.
B
- b() - Method in record class io.jenetics.ShiftMutator.Range
-
Returns the value of the
b
record component. - b() - Method in record class io.jenetics.ShuffleMutator.Range
-
Returns the value of the
b
record component. - BaseSeq<T> - Interface in io.jenetics.util
-
General base interface for an ordered, fixed sized, object sequence.
- BatchExecutor - Interface in io.jenetics.util
-
Batch executor interface, which is used for evaluating a batch of runnables.
- before(EvolutionStart<G, C>) - Method in interface io.jenetics.engine.EvolutionInterceptor
-
This method is called right before the evaluation of a generation is started.
- before(EvolutionStart<G, C>) - Method in class io.jenetics.engine.FitnessNullifier
-
Nullifies the fitness values of the population, if requested.
- best() - Method in enum class io.jenetics.Optimize
-
Return a
null
-friendly function which returns the best element of two values. - best(C, C) - Method in enum class io.jenetics.Optimize
-
Return the best value, according to this optimization direction.
- bestFitness() - Method in class io.jenetics.engine.EvolutionResult
-
Return the best population fitness.
- bestPhenotype() - Method in class io.jenetics.engine.EvolutionResult
-
Return the best
Phenotype
of the result population. - BigIntegerChromosome - Class in io.jenetics.ext
-
Numeric chromosome implementation which holds arbitrary sized integer numbers.
- BigIntegerChromosome(ISeq<BigIntegerGene>) - Constructor for class io.jenetics.ext.BigIntegerChromosome
-
Create a new chromosome from the given genes array.
- BigIntegerChromosome(BigInteger, BigInteger) - Constructor for class io.jenetics.ext.BigIntegerChromosome
-
Create a new random
DoubleChromosome
of length one. - BigIntegerChromosome(BigInteger, BigInteger, int) - Constructor for class io.jenetics.ext.BigIntegerChromosome
-
Create a new random
BigIntegerChromosome
with the givenlength
. - BigIntegerGene - Class in io.jenetics.ext
-
Numeric chromosome implementation which holds an arbitrary sized integer number.
- bind(BaseSeq<G>) - Method in class io.jenetics.ext.AbstractTreeGene
-
This method is used by the
AbstractTreeChromosome
to attach itself to this gene. - bit() - Method in enum class io.jenetics.BitGene
-
Return the value of the BitGene.
- BitChromosome - Class in io.jenetics
-
Implementation of the classical BitChromosome.
- BitChromosome(byte[]) - Constructor for class io.jenetics.BitChromosome
-
Create a new
BitChromosome
from the givenbyte
array. - BitChromosome(byte[], int, int) - Constructor for class io.jenetics.BitChromosome
-
Create a new bit chromosome from the given bit (byte) array.
- BitChromosome(byte[], int, int, double) - Constructor for class io.jenetics.BitChromosome
-
Create a new bit chromosome from the given bit (byte) array.
- bitCount() - Method in class io.jenetics.BitChromosome
-
Returns the number of bits set to true in this
BitChromosome
. - BitGene - Enum Class in io.jenetics
-
Implementation of a BitGene.
- Bnf - Class in io.jenetics.ext.grammar
-
This class contains methods for parsing and formatting context-free grammars in BNF format.
- BoltzmannSelector<G,
N> - Class in io.jenetics -
In this
Selector
, the probability for selection is defined as. - BoltzmannSelector() - Constructor for class io.jenetics.BoltzmannSelector
-
Create a new BoltzmannSelector with a default beta of 4.0.
- BoltzmannSelector(double) - Constructor for class io.jenetics.BoltzmannSelector
-
Create a new BoltzmannSelector with the given b value.
- booleanValue() - Method in class io.jenetics.BitChromosome
-
Return the value of the first gene of this chromosome.
- booleanValue() - Method in enum class io.jenetics.BitGene
-
Return the
boolean
value of this gene. - booleanValue(int) - Method in class io.jenetics.BitChromosome
-
Return the value on the specified index.
- BoolOp - Enum Class in io.jenetics.prog.op
-
This class contains basic and secondary boolean operations.
- BoundedChromosome<A,
G> - Interface in io.jenetics -
Chromosome interface for
BoundedGene
s. - BoundedGene<A,
G> - Interface in io.jenetics -
Base interface for genes where the alleles are bound by a minimum and a maximum value.
- BoundedGeneCreator<A,
G> - Interface in io.jenetics.xml -
Functional interface for creating bounded genes.
- breadthFirstIterator() - Method in class io.jenetics.ext.util.FlatTreeNode
- breadthFirstIterator() - Method in interface io.jenetics.ext.util.Tree
-
Return an iterator that traverses the subtree rooted at
this
node in breadth-first order. - breadthFirstStream() - Method in class io.jenetics.ext.util.FlatTreeNode
- breadthFirstStream() - Method in interface io.jenetics.ext.util.Tree
-
Return a stream that traverses the subtree rooted at
this
node in breadth-first order. - build() - Method in class io.jenetics.engine.Engine.Builder
-
Builds a new
Engine
instance from the set properties. - build() - Method in class io.jenetics.engine.EvolutionParams.Builder
-
Builds a new
EvolutionParams
instance from the set properties. - builder() - Static method in class io.jenetics.engine.EvolutionParams
-
Create a new evolution parameter builder.
- builder(Problem<T, G, C>) - Static method in class io.jenetics.engine.Engine
-
Create a new evolution
Engine.Builder
for the givenProblem
. - builder(Function<? super Genotype<G>, ? extends C>, Chromosome<G>, Chromosome<G>...) - Static method in class io.jenetics.engine.Engine
-
Create a new evolution
Engine.Builder
with the given fitness function and chromosome templates. - builder(Function<? super Genotype<G>, ? extends C>, Factory<Genotype<G>>) - Static method in class io.jenetics.engine.Engine
-
Create a new evolution
Engine.Builder
with the given fitness function and genotype factory. - builder(Function<? super T, ? extends C>, Codec<T, G>) - Static method in class io.jenetics.engine.Engine
-
Create a new evolution
Engine.Builder
with the given fitness function and problemcodec
. - Builder(Evaluator<G, C>, Factory<Genotype<G>>) - Constructor for class io.jenetics.engine.Engine.Builder
-
Create a new evolution
Engine.Builder
with the given fitness evaluator and genotype factory. - byExecutionTime(Duration) - Static method in class io.jenetics.engine.Limits
-
Return a predicate, which will truncate the evolution stream if the GA execution exceeds a given time duration.
- byExecutionTime(Duration, InstantSource) - Static method in class io.jenetics.engine.Limits
-
Return a predicate, which will truncate the evolution stream if the GA execution exceeds a given time duration.
- byFitnessConvergence(int, int, double) - Static method in class io.jenetics.engine.Limits
-
Return a predicate, which will truncate the evolution stream if the fitness is converging.
- byFitnessConvergence(int, int, BiPredicate<DoubleMoments, DoubleMoments>) - Static method in class io.jenetics.engine.Limits
-
Return a predicate, which will truncate the evolution stream if the fitness is converging.
- byFitnessThreshold(C) - Static method in class io.jenetics.engine.Limits
-
Return a predicate, which will truncated the evolution stream if the best fitness of the current population becomes less than the specified threshold, and the objective is set to minimize the fitness.
- byFixedGeneration(long) - Static method in class io.jenetics.engine.Limits
-
Return a predicate, which will truncate the evolution stream after the given number of generations.
- byGeneConvergence(double, double) - Static method in class io.jenetics.engine.Limits
-
A termination method that stops the evolution when a user-specified percentage of the genes (
convergedGeneRage
) that make up aGenotype
are deemed as converged. - byGeneConvergence(Predicate<DoubleMoments>, double) - Static method in class io.jenetics.engine.Limits
-
A termination method that stops the evolution when a user-specified percentage of the genes (
convergedGeneRage
) that make up aGenotype
are deemed as converged. - byPopulationConvergence(double) - Static method in class io.jenetics.engine.Limits
-
A termination method that stops the evolution when the population is deemed as converged.
- byPopulationConvergence(BiPredicate<Double, DoubleMoments>) - Static method in class io.jenetics.engine.Limits
-
A termination method that stops the evolution when the population is deemed as converged.
- bySteadyFitness(int) - Static method in class io.jenetics.engine.Limits
-
Return a predicate, which will truncate the evolution stream if no better phenotype could be found after the given number of
generations
. - byteValue() - Method in class io.jenetics.DoubleGene
- byteValue() - Method in class io.jenetics.IntegerGene
- byteValue() - Method in class io.jenetics.LongGene
- byteValue() - Method in interface io.jenetics.NumericChromosome
-
Return the byte value of this
NumericChromosome
at theindex
0. - byteValue() - Method in interface io.jenetics.NumericGene
-
Returns the value of the specified gene as a byte.
- byteValue(int) - Method in interface io.jenetics.NumericChromosome
-
Return the byte value of this
NumericChromosome
at the givenindex
.
C
- c() - Method in record class io.jenetics.ShiftMutator.Range
-
Returns the value of the
c
record component. - calculated() - Method in record class io.jenetics.prog.regression.Sampling.Result
-
Returns the value of the
calculated
record component. - CBRT - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the cube root of a double value.
- CEIL - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the smallest (closest to negative infinity) double value that is greater than or equal to the argument and is equal to a mathematical integer.
- Cfg<T> - Record Class in io.jenetics.ext.grammar
-
Represents a context-free grammar (CFG).
- Cfg(List<Cfg.NonTerminal<T>>, List<Cfg.Terminal<T>>, List<Cfg.Rule<T>>, Cfg.NonTerminal<T>) - Constructor for record class io.jenetics.ext.grammar.Cfg
-
Create a new context-free grammar object.
- Cfg.Expression<T> - Record Class in io.jenetics.ext.grammar
-
Represents one expression (list of alternative symbols) a production rule consists of.
- Cfg.NonTerminal<T> - Record Class in io.jenetics.ext.grammar
-
Represents the non-terminal symbols of the grammar (
NT
). - Cfg.Rule<T> - Record Class in io.jenetics.ext.grammar
-
Represents a production rule of the grammar (
R
). - Cfg.Symbol<T> - Interface in io.jenetics.ext.grammar
-
Represents the symbols the BNF grammar consists.
- Cfg.Terminal<T> - Record Class in io.jenetics.ext.grammar
-
Represents a terminal symbols of the grammar (
T
). - CharacterChromosome - Class in io.jenetics
-
Character chromosome which represents character sequences.
- CharacterChromosome(ISeq<CharacterGene>, IntRange) - Constructor for class io.jenetics.CharacterChromosome
-
Create a new chromosome from the given
genes
array. - CharacterGene - Class in io.jenetics
-
Character gene implementation.
- characteristics() - Method in interface io.jenetics.util.Accumulator
- charAt(int) - Method in class io.jenetics.CharacterChromosome
- charAt(int) - Method in class io.jenetics.util.CharSeq
- CharSeq - Class in io.jenetics.util
-
This class is used for holding the valid characters of an
CharacterGene
. - CharSeq(char[]) - Constructor for class io.jenetics.util.CharSeq
-
Create a new (distinct) CharSeq from the given
characters
. - CharSeq(CharSequence) - Constructor for class io.jenetics.util.CharSeq
-
Create a new (distinct) CharSeq from the given
characters
. - charValue() - Method in class io.jenetics.CharacterGene
-
Return the
char
value of this character gene. - check(Tree<? extends Op<?>, ?>) - Static method in class io.jenetics.prog.op.Program
-
Validates the given program tree.
- checkTreeState() - Method in class io.jenetics.ext.AbstractTreeGene
- childAfter(Tree<?, ?>) - Method in interface io.jenetics.ext.util.Tree
-
Return the child which comes immediately after
this
node. - childAt(int) - Method in class io.jenetics.ext.AbstractTreeGene
-
Return the child gene with the given index.
- childAt(int) - Method in class io.jenetics.ext.util.FlatTreeNode
- childAt(int) - Method in interface io.jenetics.ext.util.Tree
-
Return the child node with the given index.
- childAt(int) - Method in class io.jenetics.ext.util.TreeNode
-
Returns the child at the specified index in this node's child array.
- childAtPath(int...) - Method in interface io.jenetics.ext.util.Tree
-
Return the child node at the given
path
. - childAtPath(Tree.Path) - Method in interface io.jenetics.ext.util.Tree
-
Return the child node at the given
path
. - childBefore(Tree<?, ?>) - Method in interface io.jenetics.ext.util.Tree
-
Return the child which comes immediately before
this
node. - childCount() - Method in class io.jenetics.ext.AbstractTreeGene
- childCount() - Method in class io.jenetics.ext.util.FlatTreeNode
- childCount() - Method in interface io.jenetics.ext.util.Tree
-
Return the number of children this tree node consists of.
- childCount() - Method in class io.jenetics.ext.util.TreeNode
- childIterator() - Method in interface io.jenetics.ext.util.Tree
-
Return an iterator of the children of this
Tree
node. - childIterator() - Method in class io.jenetics.ext.util.TreeNode
- childOffset() - Method in class io.jenetics.ext.AbstractTreeGene
- childOffset() - Method in interface io.jenetics.ext.util.FlatTree
-
Return the index of the first child node in the underlying node array.
- childOffset() - Method in class io.jenetics.ext.util.FlatTreeNode
-
Return the index of the first child node in the underlying node array.
- childPath() - Method in interface io.jenetics.ext.util.Tree
-
Return the path of
this
child node from the root node. - childStream() - Method in interface io.jenetics.ext.util.Tree
-
Return a forward-order stream of this node's children.
- childStream() - Method in class io.jenetics.ext.util.TreeNode
- chromosome() - Method in class io.jenetics.Genotype
-
Return the first chromosome.
- Chromosome<G> - Interface in io.jenetics
-
A chromosome consists of one or more genes.
- clock() - Method in class io.jenetics.engine.Engine.Builder
-
Return the
InstantSource
the engine is using for measuring the execution time. - clock() - Method in class io.jenetics.engine.Engine
-
Return the
InstantSource
the engine is using for measuring the execution time. - clock(InstantSource) - Method in class io.jenetics.engine.Engine.Builder
-
The clock used for calculating the execution durations.
- close() - Method in class io.jenetics.util.StreamPublisher
-
Unless already closed, issues
onComplete
signals to current subscribers, and disallows later attempts to publish. - codec() - Method in interface io.jenetics.engine.Problem
-
Return the codec, which translates the types of the problem domain into types, which can be understood by the evolution
Engine
. - codec() - Method in class io.jenetics.prog.regression.Regression
- Codec<T,
G> - Interface in io.jenetics.engine -
A problem
Codec
contains the information about how to encode a given argument type into aGenotype
. - codecOf(ISeq<Op<T>>, ISeq<Op<T>>, int) - Static method in class io.jenetics.prog.regression.Regression
-
Create a new codec, usable for symbolic regression problems, with the given parameters.
- codecOf(ISeq<Op<T>>, ISeq<Op<T>>, int, Predicate<? super ProgramChromosome<T>>) - Static method in class io.jenetics.prog.regression.Regression
-
Create a new codec, usable for symbolic regression problems, with the given parameters.
- Codecs - Class in io.jenetics.engine
-
This class contains factory methods for creating common problem encodings.
- Codons - Class in io.jenetics.ext.grammar
-
Represents a mapping of a finite set of integers to symbol indexes.
- Codons(IntUnaryOperator, int) - Constructor for class io.jenetics.ext.grammar.Codons
-
Create a new
Codons
object from a givencodons
source and itslength
. - ColumnIndexes(int...) - Constructor for record class io.jenetics.ext.util.CsvSupport.ColumnIndexes
-
Create a new column indexes object.
- ColumnJoiner(CsvSupport.ColumnIndexes) - Constructor for class io.jenetics.ext.util.CsvSupport.ColumnJoiner
-
Create a new column joiner with the given embedding column indexes.
- ColumnJoiner(CsvSupport.Quote) - Constructor for class io.jenetics.ext.util.CsvSupport.ColumnJoiner
-
Create a new column joiner with the given parameters.
- ColumnJoiner(CsvSupport.Quote, CsvSupport.ColumnIndexes) - Constructor for class io.jenetics.ext.util.CsvSupport.ColumnJoiner
-
Create a new column joiner with the given parameters.
- ColumnJoiner(CsvSupport.Separator) - Constructor for class io.jenetics.ext.util.CsvSupport.ColumnJoiner
-
Create a new column joiner with the given parameters.
- ColumnJoiner(CsvSupport.Separator, CsvSupport.ColumnIndexes) - Constructor for class io.jenetics.ext.util.CsvSupport.ColumnJoiner
-
Create a new column joiner with the given parameters.
- ColumnJoiner(CsvSupport.Separator, CsvSupport.Quote) - Constructor for class io.jenetics.ext.util.CsvSupport.ColumnJoiner
-
Create a new column joiner with the given parameters.
- ColumnJoiner(CsvSupport.Separator, CsvSupport.Quote, CsvSupport.ColumnIndexes) - Constructor for class io.jenetics.ext.util.CsvSupport.ColumnJoiner
-
Create a new column joiner with the given parameters.
- combine(A) - Method in interface io.jenetics.util.Accumulator
-
Combines
this
accumulator with theother
one. - combine(Codec<? extends A, G>, Codec<? extends B, G>, BiFunction<? super A, ? super B, ? extends T>) - Static method in interface io.jenetics.engine.Codec
-
Converts two given
Codec
instances into one. - combine(DoubleMomentStatistics) - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Combine two
DoubleMoments
statistic objects. - combine(IntMomentStatistics) - Method in class io.jenetics.stat.IntMomentStatistics
-
Combine two
IntMoments
statistic objects. - combine(LongMomentStatistics) - Method in class io.jenetics.stat.LongMomentStatistics
-
Combine two
LongMoments
statistic objects. - combine(MinMax<C>) - Method in class io.jenetics.stat.MinMax
-
Combine two
MinMax
objects. - combine(Quantile) - Method in class io.jenetics.stat.Quantile
-
Combine two
Quantile
objects. - combine(ISeq<? extends Codec<?, G>>, Function<? super Object[], ? extends T>) - Static method in interface io.jenetics.engine.Codec
-
Combines the given
codecs
into one codec. - CombineAlterer<G,
C> - Class in io.jenetics -
Alters a chromosome by replacing two genes by the result of a given combiner function.
- CombineAlterer(BinaryOperator<G>) - Constructor for class io.jenetics.CombineAlterer
-
Create a new combiner alterer with the given arguments.
- CombineAlterer(BinaryOperator<G>, double) - Constructor for class io.jenetics.CombineAlterer
-
Create a new combiner alterer with the given arguments.
- combiner() - Method in class io.jenetics.CombineAlterer
-
Return the combiner function, used by
this
alterer. - combiner() - Method in interface io.jenetics.util.Accumulator
- comparator() - Method in interface io.jenetics.ext.moea.Vec
-
Return the comparator for comparing the elements of this MO vector.
- compare(Vec<T>, int) - Method in interface io.jenetics.ext.moea.Vec
-
Compares the
this
vector with theother
at the given componentindex
. - compare(T, int, int) - Method in interface io.jenetics.util.ProxySorter.Comparator
-
Compares the two array elements, specified by its indices, for order.
- compare(T, T) - Method in enum class io.jenetics.Optimize
-
Compares two comparable objects.
- compare(V, V, int) - Method in interface io.jenetics.ext.moea.ElementComparator
-
Compares the components of
a
andb
at the givenindex
. - compareTo(G) - Method in interface io.jenetics.BoundedGene
- compareTo(BitChromosome) - Method in class io.jenetics.BitChromosome
- compareTo(CharacterGene) - Method in class io.jenetics.CharacterGene
- compareTo(DoubleGene) - Method in class io.jenetics.DoubleGene
- compareTo(EvolutionDurations) - Method in record class io.jenetics.engine.EvolutionDurations
-
Compares two durations objects.
- compareTo(EvolutionResult<G, C>) - Method in class io.jenetics.engine.EvolutionResult
-
Compare
this
evolution result with another one, according the population's best individual. - compareTo(EnumGene<A>) - Method in class io.jenetics.EnumGene
- compareTo(Vec<T>) - Method in interface io.jenetics.ext.moea.Vec
-
The default implementation uses the
Vec.dominance(Vec)
function for defining a partial order of two vectors. - compareTo(TreePattern.Var<V>) - Method in record class io.jenetics.ext.rewriting.TreePattern.Var
- compareTo(Tree.Path) - Method in class io.jenetics.ext.util.Tree.Path
- compareTo(IntegerGene) - Method in class io.jenetics.IntegerGene
- compareTo(LongGene) - Method in class io.jenetics.LongGene
- compareTo(Phenotype<G, C>) - Method in class io.jenetics.Phenotype
- compareTo(Var<T>) - Method in class io.jenetics.prog.op.Var
- compareTo(CharSeq) - Method in class io.jenetics.util.CharSeq
- compareTo(Ordered<T>) - Method in class io.jenetics.util.Ordered
- compile(String) - Static method in class io.jenetics.ext.rewriting.TreePattern
-
Compiles the given tree pattern string.
- compile(String, Function<? super String, ? extends V>) - Static method in class io.jenetics.ext.rewriting.TreePattern
-
Compiles the given tree pattern string.
- completable(Function<? super Genotype<G>, ? extends CompletableFuture<C>>) - Static method in class io.jenetics.engine.Evaluators
-
Return a new fitness evaluator, which evaluates asynchronous fitness functions.
- completable(Function<? super T, ? extends CompletableFuture<C>>, Codec<T, G>) - Static method in class io.jenetics.engine.Evaluators
-
Return a new fitness evaluator, which evaluates asynchronous fitness functions.
- completable(Function<? super T, ? extends CompletableFuture<C>>, Function<? super Genotype<G>, ? extends T>) - Static method in class io.jenetics.engine.Evaluators
-
Return a new fitness evaluator, which evaluates asynchronous fitness functions.
- Complexity<T> - Interface in io.jenetics.prog.regression
-
Represents a complexity measure if a given program tree.
- compose(Alterer<G, C>) - Method in interface io.jenetics.Alterer
-
Returns a composed alterer that first applies the
before
alterer to its input, and then appliesthis
alterer to the result. - compose(EvolutionInterceptor<G, C>) - Method in interface io.jenetics.engine.EvolutionInterceptor
-
Composes
this
interceptor with theother
one. - concat(TreeRewriter<V>...) - Static method in interface io.jenetics.ext.rewriting.TreeRewriter
-
Concat the given
rewriters
to one tree-rewriter. - concat(ISeq<? extends T>, ISeq<? extends T>) - Static method in interface io.jenetics.util.ISeq
-
Return a sequence whose elements are all the elements of the first sequence followed by all the elements of the second sequence.
- concat(ISeq<? extends T>, T...) - Static method in interface io.jenetics.util.ISeq
-
Return a sequence whose elements are all the elements of the first sequence followed by all the elements of the vararg array.
- concat(MSeq<? extends T>, MSeq<? extends T>) - Static method in interface io.jenetics.util.MSeq
-
Return a sequence whose elements are all the elements of the first sequence followed by all the elements of the second sequence.
- concat(MSeq<? extends T>, T...) - Static method in interface io.jenetics.util.MSeq
-
Return a sequence whose elements are all the elements of the first sequence followed by all the elements of the vararg array.
- concat(Seq<? extends T>, Seq<? extends T>) - Static method in interface io.jenetics.util.Seq
-
Return a sequence whose elements are all the elements of the first sequence followed by all the elements of the second sequence.
- concat(Seq<? extends T>, T...) - Static method in interface io.jenetics.util.Seq
-
Return a sequence whose elements are all the elements of the first sequence followed by all the elements of the vararg array.
- concat(T, ISeq<? extends T>) - Static method in interface io.jenetics.util.ISeq
-
Return a sequence whose elements are all the elements of the first element followed by all the elements of the sequence.
- concat(T, MSeq<? extends T>) - Static method in interface io.jenetics.util.MSeq
-
Return a sequence whose elements are all the elements of the first element followed by all the elements of the sequence.
- concat(T, Seq<? extends T>) - Static method in interface io.jenetics.util.Seq
-
Return a sequence whose elements are all the elements of the first element followed by all the elements of the sequence.
- ConcatEngine<G,
C> - Class in io.jenetics.ext.engine -
The
ConcatEngine
lets you concatenate two (or more) evolutionEngine
, with different configurations, and let it use as one engineEvolutionStreamable
. - ConcatEngine(List<? extends EvolutionStreamable<G, C>>) - Constructor for class io.jenetics.ext.engine.ConcatEngine
-
Create a new concatenating evolution engine with the given list of engines.
- Concurrency - Search tag in class io.jenetics.engine.Engine
- Section
- Const - Search tag in package io.jenetics.prog.op
- Section
- Const<T> - Class in io.jenetics.prog.op
-
Represents an operation which always returns the same, constant, value.
- CONST_REWRITER - Static variable in class io.jenetics.prog.op.MathExpr
-
This tree-rewriter rewrites constant expressions to its single value.
- constrain(Codec<T, G>) - Method in interface io.jenetics.engine.Constraint
-
Wraps the given codec into a codec, which obeys
this
constraint. - constrain(InvertibleCodec<T, G>) - Method in interface io.jenetics.engine.Constraint
-
Wraps the given codec into a codec, which obeys
this
constraint. - constrain(Factory<Genotype<G>>) - Method in interface io.jenetics.engine.Constraint
-
Wraps the given genotype factory into a factory, which only creates individuals obeying
this
constraint. - constraint() - Method in class io.jenetics.engine.Engine.Builder
-
Return the constraint of the evolution problem.
- constraint() - Method in class io.jenetics.engine.Engine
-
Return the constraint of the evolution problem.
- constraint() - Method in interface io.jenetics.engine.Problem
-
Return the constraint, associated with
this
problem, if available. - constraint(Constraint<G, C>) - Method in class io.jenetics.engine.Engine.Builder
-
The phenotype constraint is used for detecting invalid individuals and repairing them.
- Constraint<G,
C> - Interface in io.jenetics.engine -
This interface allows you to define constraints on single phenotypes.
- ConstRewriter<T> - Class in io.jenetics.prog.op
-
This class rewrites constant expressions to its single value.
- contains(char) - Method in class io.jenetics.util.CharSeq
-
Test whether this character set contains the given character
c
. - contains(double) - Method in class io.jenetics.util.DoubleRange
-
Checks whether the given
value
is within the range[min, max)
. - contains(int) - Method in class io.jenetics.util.IntRange
-
Checks whether the given
value
is within the range[min, max)
. - contains(long) - Method in class io.jenetics.util.LongRange
-
Checks whether the given
value
is within the range[min, max)
. - contains(Character) - Method in class io.jenetics.util.CharSeq
-
Test whether this character set contains the given character
c
. - contains(Object) - Method in class io.jenetics.util.CharSeq
- contains(Object) - Method in interface io.jenetics.util.Seq
-
Returns
true
if this sequence contains the specified element. - contiguity() - Method in class io.jenetics.ext.SimulatedBinaryCrossover
-
Return the contiguity value of the crossover.
- Conversions - Class in io.jenetics.util
-
This class contains methods for converting from and to the primitive arrays
int[]
,long[]
anddouble[]
. - copy() - Method in class io.jenetics.engine.Engine.Builder
-
Create a new builder, with the current configuration.
- copy() - Method in class io.jenetics.ext.util.TreeNode
- copy() - Method in interface io.jenetics.util.Copyable
-
Return a new copy of type
T
. - copy() - Method in interface io.jenetics.util.ISeq
-
Return a shallow copy of this sequence.
- Copyable<T> - Interface in io.jenetics.util
-
This interface indicates that a class can create a copy of type
T
. - COS - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the trigonometric cosine of an angle.
- COSH - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the hyperbolic cosine of a double value.
- count() - Method in record class io.jenetics.stat.DoubleMoments
-
Returns the value of the
count
record component. - count() - Method in record class io.jenetics.stat.DoubleSummary
-
Returns the value of the
count
record component. - count() - Method in record class io.jenetics.stat.IntMoments
-
Returns the value of the
count
record component. - count() - Method in record class io.jenetics.stat.IntSummary
-
Returns the value of the
count
record component. - count() - Method in record class io.jenetics.stat.LongMoments
-
Returns the value of the
count
record component. - count() - Method in record class io.jenetics.stat.LongSummary
-
Returns the value of the
count
record component. - count() - Method in class io.jenetics.stat.MinMax
-
Returns the count of values recorded.
- count() - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Returns the count of values recorded.
- count() - Method in class io.jenetics.stat.IntMomentStatistics
-
Returns the count of values recorded.
- count() - Method in class io.jenetics.stat.LongMomentStatistics
-
Returns the count of values recorded.
- count() - Method in class io.jenetics.stat.Quantile
-
Return the number of samples the quantile value was calculated of.
- count(Tree<?, ?>, int) - Static method in interface io.jenetics.prog.regression.Complexity
-
This method uses the node count of a program tree for calculating its complexity.
- create(A, A, A) - Method in interface io.jenetics.xml.BoundedGeneCreator
-
Create a new bounded gene from the given parameters.
- crossover(TreeNode<A>, TreeNode<A>) - Method in class io.jenetics.ext.SingleNodeCrossover
- crossover(TreeNode<A>, TreeNode<A>) - Method in class io.jenetics.ext.TreeCrossover
-
Template method which performs the crossover.
- crossover(MSeq<G>, MSeq<G>) - Method in class io.jenetics.Crossover
-
Template method which performs the crossover.
- crossover(MSeq<G>, MSeq<G>) - Method in class io.jenetics.ext.SimulatedBinaryCrossover
- crossover(MSeq<G>, MSeq<G>) - Method in class io.jenetics.IntermediateCrossover
- crossover(MSeq<G>, MSeq<G>) - Method in class io.jenetics.LineCrossover
- crossover(MSeq<G>, MSeq<G>) - Method in class io.jenetics.MultiPointCrossover
- crossover(MSeq<G>, MSeq<G>) - Method in class io.jenetics.SinglePointCrossover
- crossover(MSeq<G>, MSeq<G>) - Method in class io.jenetics.UniformCrossover
- crossover(MSeq<EnumGene<T>>, MSeq<EnumGene<T>>) - Method in class io.jenetics.PartiallyMatchedCrossover
- crossover(MSeq<EnumGene<T>>, MSeq<EnumGene<T>>) - Method in class io.jenetics.UniformOderBasedCrossover
-
Applies uniform order-based crossover to two sequences.
- Crossover<G,
C> - Class in io.jenetics -
Performs a Crossover of two
Chromosome
. - Crossover(double) - Constructor for class io.jenetics.Crossover
-
Constructs an alterer with a given recombination probability.
- crossoverPointCount() - Method in class io.jenetics.MultiPointCrossover
-
Return the number of crossover points.
- crowdingDistance(BaseSeq<? extends Vec<T>>) - Static method in class io.jenetics.ext.moea.Pareto
-
The crowding distance value of a solution provides an estimate of the density of solutions surrounding that solution.
- crowdingDistance(BaseSeq<? extends T>, ElementComparator<? super T>, ElementDistance<? super T>, ToIntFunction<? super T>) - Static method in class io.jenetics.ext.moea.Pareto
-
The crowding distance value of a solution provides an estimate of the density of solutions surrounding that solution.
- CsvSupport - Class in io.jenetics.ext.util
-
This class contains helper classes, which are the building blocks for handling CSV files.
- CsvSupport.ColumnIndexes - Record Class in io.jenetics.ext.util
-
Holds the column indexes, which should be part of the split or join operation.
- CsvSupport.ColumnJoiner - Class in io.jenetics.ext.util
-
This class joins an array of columns into one CSV line.
- CsvSupport.LineReader - Class in io.jenetics.ext.util
-
This class reads CSV files and splits it into lines.
- CsvSupport.LineSplitter - Class in io.jenetics.ext.util
-
Splitting a CSV line into columns (records).
- CsvSupport.Quote - Record Class in io.jenetics.ext.util
-
Holds the CSV column quote character.
- CsvSupport.Separator - Record Class in io.jenetics.ext.util
-
Holds the CSV column separator character.
- CyclicEngine<G,
C> - Class in io.jenetics.ext.engine -
The
CyclicEngine
lets you concatenate two (or more) evolutionEngine
, with different configurations, and let it use as one engineEvolutionStreamable
. - CyclicEngine(List<? extends EvolutionStreamable<G, C>>) - Constructor for class io.jenetics.ext.engine.CyclicEngine
-
Create a new cycling evolution engine with the given list of
engines
.
D
- data() - Method in interface io.jenetics.ext.moea.Vec
-
Return the underlying data structure.
- decode(Genotype<G>) - Method in interface io.jenetics.engine.Codec
- decode(Genotype<G>) - Method in interface io.jenetics.engine.Problem
- decoder() - Method in interface io.jenetics.engine.Codec
-
Return the decoder function which transforms the genotype back to the original problem domain representation.
- DEFAULT - Static variable in class io.jenetics.ext.util.CsvSupport.ColumnJoiner
-
Default column joiner, which is using default separator character,
CsvSupport.Separator.DEFAULT
, and default quote character,CsvSupport.Quote.DEFAULT
. - DEFAULT - Static variable in record class io.jenetics.ext.util.CsvSupport.Quote
-
The default quote character, '
"
'. - DEFAULT - Static variable in record class io.jenetics.ext.util.CsvSupport.Separator
-
The default separator character, '
,
'. - DEFAULT_ALTER_PROBABILITY - Static variable in interface io.jenetics.Alterer
-
The default alter probability: 0.2
- DEFAULT_CHARACTERS - Static variable in class io.jenetics.CharacterGene
-
The default character set used by this gene.
- DEFAULT_RETRY_COUNT - Static variable in class io.jenetics.engine.RetryConstraint
-
The default retry-count for creating new, valid phenotypes.
- depth() - Method in interface io.jenetics.ext.util.Tree
-
Returns the depth of the tree rooted at this node.
- depthFirstIterator() - Method in interface io.jenetics.ext.util.Tree
-
Return an iterator that traverses the subtree rooted at
this
node in depth-first order. - depthFirstStream() - Method in interface io.jenetics.ext.util.Tree
-
Return a stream that traverses the subtree rooted at
this
node in depth-first. - DerivationTreeGenerator<T> - Class in io.jenetics.ext.grammar
-
Standard implementation of a derivation-tree generator.
- DerivationTreeGenerator(SymbolIndex, int) - Constructor for class io.jenetics.ext.grammar.DerivationTreeGenerator
-
Create a new derivation tree generator from the given parameters.
- descending() - Method in enum class io.jenetics.Optimize
-
Create an appropriate comparator of the given optimization strategy.
- detach() - Method in class io.jenetics.ext.util.TreeNode
-
Detaches the subtree rooted at
this
node from the tree, givingthis
node anull
parent. - distance() - Method in interface io.jenetics.ext.moea.Vec
-
Return a function which calculates the element distance of a vector at a given element index.
- distance(Vec<T>, int) - Method in interface io.jenetics.ext.moea.Vec
-
Calculates the distance between two vector elements at the given
index
. - distance(V, V, int) - Method in interface io.jenetics.ext.moea.ElementDistance
-
Calculates the distance of two vector elements at the given
index
. - DIV - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the quotient of its arguments.
- doc(Writer<? super T>) - Static method in interface io.jenetics.xml.stream.Writer
-
Adds an XML prolog element written by the given
writer
. - dominance() - Method in interface io.jenetics.ext.moea.Vec
-
Return the comparator which defines the (Pareto) dominance measure.
- dominance(double[], double[]) - Static method in class io.jenetics.ext.moea.Pareto
-
Calculates the Pareto Dominance of the two vectors u and v.
- dominance(double[], double[]) - Static method in interface io.jenetics.ext.moea.Vec
-
Calculates the Pareto Dominance of the two vectors u and v.
- dominance(int[], int[]) - Static method in class io.jenetics.ext.moea.Pareto
-
Calculates the Pareto Dominance of the two vectors u and v.
- dominance(int[], int[]) - Static method in interface io.jenetics.ext.moea.Vec
-
Calculates the Pareto Dominance of the two vectors u and v.
- dominance(long[], long[]) - Static method in class io.jenetics.ext.moea.Pareto
-
Calculates the Pareto Dominance of the two vectors u and v.
- dominance(long[], long[]) - Static method in interface io.jenetics.ext.moea.Vec
-
Calculates the Pareto Dominance of the two vectors u and v.
- dominance(C[], C[]) - Static method in class io.jenetics.ext.moea.Pareto
-
Calculates the Pareto Dominance of the two vectors u and v.
- dominance(C[], C[]) - Static method in interface io.jenetics.ext.moea.Vec
-
Calculates the Pareto Dominance of the two vectors u and v.
- dominance(Vec<T>) - Method in interface io.jenetics.ext.moea.Vec
- dominance(T[], T[], Comparator<? super T>) - Static method in class io.jenetics.ext.moea.Pareto
-
Calculates the Pareto Dominance of the two vectors u and v.
- dominance(T[], T[], Comparator<? super T>) - Static method in interface io.jenetics.ext.moea.Vec
-
Calculates the Pareto Dominance of the two vectors u and v.
- dominance(V, V, int, ElementComparator<? super V>) - Static method in class io.jenetics.ext.moea.Pareto
-
Calculates the Pareto Dominance of the two vectors u and v.
- dot(String) - Static method in class io.jenetics.ext.util.TreeFormatter
-
A tree formatter for .dot string representations.
- DOT - Static variable in class io.jenetics.ext.util.TreeFormatter
-
A tree formatter for .dot string representations.
- DOUBLE - Static variable in class io.jenetics.prog.op.ConstRewriter
-
Const rewriter for double operation trees.
- DoubleChromosome - Class in io.jenetics
-
Numeric chromosome implementation which holds 64-bit floating point numbers.
- DoubleChromosome(ISeq<DoubleGene>, IntRange) - Constructor for class io.jenetics.DoubleChromosome
-
Create a new chromosome from the given
genes
and the allowed length range of the chromosome. - DoubleGene - Class in io.jenetics
-
Implementation of the NumericGene which holds a 64-bit floating point number.
- DoubleMoments - Record Class in io.jenetics.stat
-
Value objects which contains statistical moments.
- DoubleMoments(long, double, double, double, double, double, double, double) - Constructor for record class io.jenetics.stat.DoubleMoments
-
Creates an instance of a
DoubleMoments
record class. - DoubleMomentStatistics - Class in io.jenetics.stat
-
A state object for collecting statistics such as count, min, max, sum, mean, variance, skewness and kurtosis.
- DoubleMomentStatistics() - Constructor for class io.jenetics.stat.DoubleMomentStatistics
-
Create an empty moments object.
- DoubleRange - Class in io.jenetics.util
-
Double range class.
- doubles() - Method in class io.jenetics.util.RandomAdapter
- doubles(double, double) - Method in class io.jenetics.util.RandomAdapter
- doubles(long) - Method in class io.jenetics.util.RandomAdapter
- doubles(long, double, double) - Method in class io.jenetics.util.RandomAdapter
- doubleStream() - Method in class io.jenetics.DoubleChromosome
-
Returns a sequential stream of the alleles with this chromosome as its source.
- DoubleSummary - Record Class in io.jenetics.stat
-
Value objects which contains statistical summary information.
- DoubleSummary(long, double, double, double, double) - Constructor for record class io.jenetics.stat.DoubleSummary
-
Creates an instance of a
DoubleSummary
record class. - doubleToIntArray(double[]) - Static method in class io.jenetics.util.Conversions
-
Converts the given
long[]
array
to adouble[]
array. - doubleToIntArray(double[], DoubleToIntFunction) - Static method in class io.jenetics.util.Conversions
-
Converts the given
double[]
array
to aint[]
array. - doubleToIntArray(DoubleToIntFunction) - Static method in class io.jenetics.util.Conversions
-
Return an array mapper function which applies the given
mapper
to every array element. - doubleToLongArray(double[]) - Static method in class io.jenetics.util.Conversions
-
Converts the given
long[]
array
to adouble[]
array. - doubleToLongArray(double[], DoubleToLongFunction) - Static method in class io.jenetics.util.Conversions
-
Converts the given
double[]
array
to along[]
array. - doubleToLongArray(DoubleToLongFunction) - Static method in class io.jenetics.util.Conversions
-
Return an array mapper function which applies the given
mapper
to every array element. - doubleValue() - Method in class io.jenetics.BitChromosome
-
Return the double value this BitChromosome represents.
- doubleValue() - Method in class io.jenetics.DoubleGene
- doubleValue() - Method in class io.jenetics.IntegerGene
- doubleValue() - Method in class io.jenetics.LongGene
- doubleValue() - Method in interface io.jenetics.NumericChromosome
-
Return the double value of this
NumericChromosome
at theindex
0. - doubleValue() - Method in interface io.jenetics.NumericGene
-
Returns the value of the specified gene as a double.
- doubleValue(int) - Method in interface io.jenetics.NumericChromosome
-
Return the double value of this
NumericChromosome
at the givenindex
. - durations() - Method in class io.jenetics.engine.EvolutionResult
-
Return the timing (meta) information of the evolution step.
E
- E - Static variable in enum class io.jenetics.prog.op.MathOp
-
The double value that is closer than any other to e, the base of the natural logarithms.
- E(Cfg.Symbol<T>...) - Static method in record class io.jenetics.ext.grammar.Cfg
-
Factory method for creating an expression with the given
symbols
. - elem(String, Reader<? extends T>) - Static method in class io.jenetics.xml.stream.Reader
-
Return a
Reader
which reads the value from the child elements of the given parent elementname
. - elem(String, Writer<? super T>...) - Static method in interface io.jenetics.xml.stream.Writer
-
Create a new
Writer
, which writes an XML element with the given name and writes the given children into it. - elem(Function<Object[], T>, String, Reader<?>...) - Static method in class io.jenetics.xml.stream.Reader
-
Return a
Reader
for reading an object of typeT
from the XML element with the givenname
. - ElementComparator<V> - Interface in io.jenetics.ext.moea
-
Defines the order of two elements of a given vector type
V
. - ElementDistance<V> - Interface in io.jenetics.ext.moea
-
Defines the distance of two elements of a given vector type
V
. - elems(Reader<? extends T>) - Static method in class io.jenetics.xml.stream.Reader
-
Return a
Reader
which collects the elements, read by the given childreader
, and returns it as a list of these elements. - elems(Writer<? super T>) - Static method in interface io.jenetics.xml.stream.Writer
-
Creates a new
Writer
, which writes the givenchildren
as sub-elements, defined by the givenchildWriter
. - elems(String, Writer<? super T>) - Static method in interface io.jenetics.xml.stream.Writer
-
Creates a new
Writer
, which writes the givenchildren
as sub-elements, defined by the givenchildWriter
. - EliteSelector<G,
C> - Class in io.jenetics -
The
EliteSelector
copies a small proportion of the fittest candidates, without changes, into the next generation. - EliteSelector() - Constructor for class io.jenetics.EliteSelector
-
Create a new elite selector with elite count 1, and the selector for selecting the rest of the population is initialized with
TournamentSelector<>(3)
- EliteSelector(int) - Constructor for class io.jenetics.EliteSelector
-
Create a new elite selector with the desired number of elites to be selected.
- EliteSelector(int, Selector<G, C>) - Constructor for class io.jenetics.EliteSelector
-
Create a new elite selector with the desired number of elites to be selected, and the selector used for selecting the rest of the population.
- EliteSelector(Selector<G, C>) - Constructor for class io.jenetics.EliteSelector
-
Create a new elite selector with selector used for selecting the rest of the population.
- empty() - Static method in class io.jenetics.engine.EvolutionStart
-
An empty evolution start object, which can be used as initial evolution value.
- empty() - Static method in interface io.jenetics.util.ISeq
-
Return an empty
ISeq
. - empty() - Static method in interface io.jenetics.util.MSeq
-
Return an empty
MSeq
. - empty() - Static method in interface io.jenetics.util.Seq
-
Return an empty
Seq
. - EMPTY - Static variable in interface io.jenetics.util.ISeq
-
Single instance of an empty
ISeq
. - EMPTY - Static variable in interface io.jenetics.util.MSeq
-
Single instance of an empty
MSeq
. - EMPTY - Static variable in interface io.jenetics.util.Seq
-
Single instance of an empty
Seq
. - encode(T) - Method in interface io.jenetics.engine.InvertibleCodec
-
Decodes the given
value
, which is an element of the native problem domain, into aGenotype
. - encoder() - Method in interface io.jenetics.engine.InvertibleCodec
-
Return the encoder function which transforms a value from the native problem domain back to the genotype.
- encoding() - Method in interface io.jenetics.engine.Codec
-
Return the genotype factory for creating genotypes with the right encoding for the given problem.
- Engine<G,
C> - Class in io.jenetics.engine -
Genetic algorithm engine which is the main class.
- Engine.Builder<G,
C> - Class in io.jenetics.engine -
Builder class for building GA
Engine
instances. - Engine.Setup<G,
C> - Interface in io.jenetics.engine -
This interface represents a recipe for configuring (setup) a given
Engine.Builder
. - EnumGene<A> - Class in io.jenetics
-
Gene which holds enumerable (countable) genes.
- EOL - Static variable in class io.jenetics.ext.util.CsvSupport
-
The newline string used for writing the CSV file:
\r\n
. - EphemeralConst - Search tag in package io.jenetics.prog.op
- Section
- EphemeralConst<T> - Class in io.jenetics.prog.op
-
Implementation of an ephemeral constant.
- EQU - Enum constant in enum class io.jenetics.prog.op.BoolOp
-
Equivalence.
- equals(Tree<?, ?>, Tree<?, ?>) - Static method in interface io.jenetics.ext.util.Tree
-
Checks if the two given trees has the same structure with the same values.
- equals(BaseSeq<?>, Object) - Static method in interface io.jenetics.util.Seq
-
Unified method for compare to sequences for equality.
- equals(Object) - Method in class io.jenetics.DoubleChromosome
- equals(Object) - Method in class io.jenetics.IntegerChromosome
- equals(Object) - Method in class io.jenetics.LongChromosome
- equals(Object) - Method in class io.jenetics.AbstractChromosome
- equals(Object) - Method in record class io.jenetics.AltererResult
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in class io.jenetics.AnyGene
- equals(Object) - Method in class io.jenetics.BitChromosome
- equals(Object) - Method in class io.jenetics.CharacterChromosome
- equals(Object) - Method in class io.jenetics.CharacterGene
- equals(Object) - Method in class io.jenetics.DoubleGene
- equals(Object) - Method in record class io.jenetics.engine.EvolutionDurations
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in class io.jenetics.engine.EvolutionInit
- equals(Object) - Method in class io.jenetics.engine.EvolutionResult
- equals(Object) - Method in class io.jenetics.engine.EvolutionStart
- equals(Object) - Method in class io.jenetics.EnumGene
- equals(Object) - Method in class io.jenetics.ext.AbstractTreeGene
- equals(Object) - Method in class io.jenetics.ext.BigIntegerGene
- equals(Object) - Method in record class io.jenetics.ext.grammar.Cfg
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.ext.grammar.Cfg.Expression
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.ext.grammar.Cfg.NonTerminal
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.ext.grammar.Cfg.Rule
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.ext.grammar.Cfg.Terminal
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in class io.jenetics.ext.rewriting.TreeMatchResult
- equals(Object) - Method in class io.jenetics.ext.rewriting.TreePattern
- equals(Object) - Method in record class io.jenetics.ext.rewriting.TreePattern.Val
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.ext.rewriting.TreePattern.Var
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in class io.jenetics.ext.rewriting.TreeRewriteRule
- equals(Object) - Method in class io.jenetics.ext.rewriting.TRS
- equals(Object) - Method in record class io.jenetics.ext.util.CsvSupport.ColumnIndexes
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.ext.util.CsvSupport.Quote
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.ext.util.CsvSupport.Separator
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in class io.jenetics.ext.util.FlatTreeNode
- equals(Object) - Method in class io.jenetics.ext.util.Tree.Path
- equals(Object) - Method in class io.jenetics.ext.util.TreeNode
- equals(Object) - Method in class io.jenetics.Genotype
- equals(Object) - Method in class io.jenetics.IntegerGene
- equals(Object) - Method in class io.jenetics.LongGene
- equals(Object) - Method in record class io.jenetics.MutatorResult
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in class io.jenetics.Phenotype
- equals(Object) - Method in class io.jenetics.prog.op.MathExpr
- equals(Object) - Method in class io.jenetics.prog.op.Program
- equals(Object) - Method in class io.jenetics.prog.op.Val
- equals(Object) - Method in class io.jenetics.prog.op.Var
- equals(Object) - Method in record class io.jenetics.prog.regression.Sampling.Result
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.ShiftMutator.Range
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.ShuffleMutator.Range
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.stat.DoubleMoments
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.stat.DoubleSummary
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.stat.IntMoments
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.stat.IntSummary
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.stat.LongMoments
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in record class io.jenetics.stat.LongSummary
-
Indicates whether some other object is "equal to" this one.
- equals(Object) - Method in class io.jenetics.util.CharSeq
- equals(Object) - Method in class io.jenetics.util.DoubleRange
- equals(Object) - Method in class io.jenetics.util.IntRange
- equals(Object) - Method in class io.jenetics.util.LongRange
- equals(Object) - Method in class io.jenetics.util.NanoClock
- equals(Object) - Method in interface io.jenetics.util.Seq
-
Compares the specified object with this sequence for equality.
- equals(Object) - Method in class io.jenetics.AnyChromosome
- error(Tree<? extends Op<T>, ?>) - Method in class io.jenetics.prog.regression.Regression
-
Calculates the actual error for the given
program
. - Error<T> - Interface in io.jenetics.prog.regression
-
This function calculates the overall error of a given program tree.
- eval(boolean...) - Method in enum class io.jenetics.prog.op.BoolOp
-
Evaluates the operation with the given arguments.
- eval(double...) - Method in class io.jenetics.prog.op.MathExpr
-
Convenient method, which lets you apply the program function without explicitly create a wrapper array.
- eval(double...) - Method in enum class io.jenetics.prog.op.MathOp
-
Evaluates the operation with the given arguments.
- eval(A...) - Method in class io.jenetics.prog.ProgramChromosome
-
Evaluates the root node of this chromosome.
- eval(A...) - Method in class io.jenetics.prog.ProgramGene
-
Convenient method, which lets you apply the program function without explicitly create a wrapper array.
- eval(Tree<? extends Op<Double>, ?>, double...) - Static method in class io.jenetics.prog.op.MathExpr
-
Evaluates the given
expression
with the given arguments. - eval(Tree<? extends Op<T>, ?>) - Method in class io.jenetics.prog.regression.SampleBuffer
- eval(Tree<? extends Op<T>, ?>) - Method in interface io.jenetics.prog.regression.Sampling
-
Evaluates the given
program
tree with its sample points. - eval(Tree<? extends Op<T>, ?>, T...) - Static method in class io.jenetics.prog.op.Program
-
Evaluates the given operation tree with the given variables.
- eval(Seq<Phenotype<G, C>>) - Method in class io.jenetics.engine.Engine
-
Evaluates the fitness function of the given population with the configured
Evaluator
of this engine and returns a new population with its fitness value assigned. - eval(Seq<Phenotype<G, C>>) - Method in interface io.jenetics.engine.Evaluator
-
Evaluates the fitness values of the given
population
. - eval(String, double...) - Static method in class io.jenetics.prog.op.MathExpr
-
Evaluates the given
expression
with the given arguments. - eval(Function<? super Genotype<G>, ? extends C>) - Method in class io.jenetics.Phenotype
-
Applies the given fitness function to the underlying genotype and return a new phenotype with the (newly) evaluated fitness function, if not already evaluated.
- eval(Function<? super T[], ? extends T>) - Method in class io.jenetics.prog.regression.SampleBuffer
- eval(Function<? super T[], ? extends T>) - Method in interface io.jenetics.prog.regression.Sampling
-
Evaluates the given
function
tree with its sample points. - eval(T...) - Method in class io.jenetics.prog.op.Program
-
Convenient method, which lets you apply the program function without explicitly create a wrapper array.
- evaluationDuration() - Method in record class io.jenetics.engine.EvolutionDurations
-
Returns the value of the
evaluationDuration
record component. - evaluationDuration() - Method in class io.jenetics.engine.EvolutionStatistics
-
Return the duration statistics needed for evaluating the fitness function of the new individuals, in seconds.
- Evaluator<G,
C> - Interface in io.jenetics.engine -
This interface allows defining different strategies for evaluating the fitness functions of a given population.
- Evaluators - Class in io.jenetics.engine
-
This class contains factory methods for creating commonly usable
Evaluator
implementations. - Evolution<G,
C> - Interface in io.jenetics.engine -
This functional interface defines the evolution function, which takes an
EvolutionStart
object, evolves the population, and returns anEvolutionResult
object. - EvolutionDurations - Record Class in io.jenetics.engine
-
This class contains timing information about one evolution step.
- EvolutionDurations(Duration, Duration, Duration, Duration, Duration, Duration, Duration) - Constructor for record class io.jenetics.engine.EvolutionDurations
-
Creates an instance of a
EvolutionDurations
record class. - EvolutionInit<G> - Class in io.jenetics.engine
-
Represents the initialization value of an evolution stream/iterator.
- EvolutionInterceptor<G,
C> - Interface in io.jenetics.engine -
The evolution interceptor allows updating the
EvolutionStart
object, before the evolution start, and update theEvolutionResult
object after the evolution. - evolutionParams() - Method in class io.jenetics.engine.Engine.Builder
-
Return the currently set evolution parameters.
- evolutionParams(EvolutionParams<G, C>) - Method in class io.jenetics.engine.Engine.Builder
-
Set the evolution parameters used by the engine.
- evolutionParams(EvolutionParams<G, C>) - Method in class io.jenetics.engine.EvolutionParams.Builder
- EvolutionParams<G,
C> - Class in io.jenetics.engine -
This class collects the parameters which control the behavior of the evolution process.
- EvolutionParams.Builder<G,
C> - Class in io.jenetics.engine -
Builder class for the evolution parameter.
- EvolutionResult<G,
C> - Class in io.jenetics.engine -
Represents a state of the GA after an evolution step.
- EvolutionStart<G,
C> - Class in io.jenetics.engine -
Represents a state of the GA at the start of an evolution step.
- EvolutionStatistics<C,
FitnessStatistics> - Class in io.jenetics.engine -
This class can be used to gather additional statistic information of an evolution process.
- EvolutionStream<G,
C> - Interface in io.jenetics.engine -
The
EvolutionStream
class extends the JavaStream
and adds a method for limiting the evolution by a given predicate. - EvolutionStreamable<G,
C> - Interface in io.jenetics.engine -
This interface defines the capability of creating
EvolutionStream
s from a givenEvolutionStart
object. - evolve(EvolutionStart<G, C>) - Method in class io.jenetics.engine.Engine
- evolve(EvolutionStart<G, C>) - Method in interface io.jenetics.engine.Evolution
-
Perform one evolution step with the given evolution
start
object New phenotypes are created with the fitness function defined by this engine - evolve(ISeq<Phenotype<G, C>>, long) - Method in interface io.jenetics.engine.Evolution
-
Perform one evolution step with the given
population
andgeneration
. - evolveDuration() - Method in record class io.jenetics.engine.EvolutionDurations
-
Returns the value of the
evolveDuration
record component. - evolveDuration() - Method in class io.jenetics.engine.EvolutionStatistics
-
Return the duration statistics needed for the whole evolved step, in seconds.
- Example - Search tag in package io.jenetics.prog
- Section
- Examples - Search tag in class io.jenetics.ext.util.CsvSupport.ColumnJoiner
- Section
- Examples - Search tag in class io.jenetics.ext.util.CsvSupport.LineSplitter
- Section
- execute(BaseSeq<? extends Runnable>) - Method in interface io.jenetics.util.BatchExecutor
-
Executes the runnables of the
batch
concurrently and returns, when all tasks have been executed. - executor() - Method in class io.jenetics.engine.Engine.Builder
-
Return the
Executor
the engine is using for executing the evolution steps. - executor() - Method in class io.jenetics.engine.Engine
-
Return the
Executor
the engine is using for executing the evolution steps. - executor(Executor) - Method in class io.jenetics.engine.Engine.Builder
-
The executor used by the engine.
- EXP - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns Euler's number e raised to the power of a double value.
- expand(char, char) - Static method in class io.jenetics.util.CharSeq
-
Expands the characters between
a
andb
. - expand(CharSequence) - Static method in class io.jenetics.util.CharSeq
-
Expands the character range for the given
pattern
. - expand(Map<TreePattern.Var<V>, Tree<V, ?>>) - Method in class io.jenetics.ext.rewriting.TreePattern
-
Expands
this
pattern with the given variable mapping. - expected() - Method in record class io.jenetics.prog.regression.Sampling.Result
-
Returns the value of the
expected
record component. - ExponentialRankSelector<G,
C> - Class in io.jenetics -
An alternative to the "weak"
LinearRankSelector
is to assign survival probabilities to the sorted individuals using an exponential function. - ExponentialRankSelector() - Constructor for class io.jenetics.ExponentialRankSelector
-
Create a new selector with the default value of 0.975.
- ExponentialRankSelector(double) - Constructor for class io.jenetics.ExponentialRankSelector
-
Create a new exponential rank selector.
- Expression(List<Cfg.Symbol<T>>) - Constructor for record class io.jenetics.ext.grammar.Cfg.Expression
-
Creates an instance of a
Expression
record class.
F
- Factory<T> - Interface in io.jenetics.util
- FALSE - Enum constant in enum class io.jenetics.BitGene
- FALSE - Static variable in enum class io.jenetics.prog.op.BoolOp
-
Represents the constant
true
. - fill(Supplier<? extends T>) - Method in interface io.jenetics.util.MSeq
-
Fill the sequence with values generated by the given factory.
- finisher() - Method in interface io.jenetics.util.Accumulator
- firstChild() - Method in interface io.jenetics.ext.util.Tree
-
Return the first child of
this
node, orOptional.empty()
ifthis
node has no children. - firstLeaf() - Method in interface io.jenetics.ext.util.Tree
-
Return the first leaf that is a descendant of
this
node; either this node or its first child's first leaf. - fitness() - Method in class io.jenetics.engine.EvolutionStatistics
-
Return the minimal and maximal fitness.
- fitness() - Method in interface io.jenetics.engine.Problem
-
Return the fitness function of the problem in the native problem domain.
- fitness() - Method in class io.jenetics.Phenotype
-
Return the fitness value of this
Phenotype
. - fitness() - Method in class io.jenetics.prog.regression.Regression
- fitness(Genotype<G>) - Method in interface io.jenetics.engine.Problem
-
Returns the fitness value for the given argument.
- fitness(T) - Method in interface io.jenetics.engine.Problem
-
Returns the fitness value for the given argument.
- fitnessExecutor() - Method in class io.jenetics.engine.Engine.Builder
-
Return the batch executor, used for evaluating the fitness functions.
- fitnessExecutor(BatchExecutor) - Method in class io.jenetics.engine.Engine.Builder
-
This executor is used for evaluating the fitness functions.
- FitnessNullifier<G,
C> - Class in io.jenetics.engine -
This class allows forcing a reevaluation of the fitness function.
- FitnessNullifier() - Constructor for class io.jenetics.engine.FitnessNullifier
- fitnessOptional() - Method in class io.jenetics.Phenotype
-
Return the fitness value of
this
phenotype, orOptional.empty()
if not evaluated yet. - flattenedNodes() - Method in class io.jenetics.ext.AbstractTreeGene
-
Return the whole flattened tree values in breadth-first order.
- flattenedNodes() - Method in interface io.jenetics.ext.util.FlatTree
-
Return the whole flattened tree values in breadth-first order.
- flattenedNodes() - Method in class io.jenetics.ext.util.FlatTreeNode
- FlatTree<V,
T> - Interface in io.jenetics.ext.util -
Tree specification, where the nodes of the whole tree are stored in an array.
- FlatTreeNode<V> - Class in io.jenetics.ext.util
-
Default implementation of the
FlatTree
interface. - floatValue() - Method in class io.jenetics.BitChromosome
-
Return the float value this BitChromosome represents.
- floatValue() - Method in class io.jenetics.DoubleGene
- floatValue() - Method in class io.jenetics.IntegerGene
- floatValue() - Method in class io.jenetics.LongGene
- floatValue() - Method in interface io.jenetics.NumericChromosome
-
Return the float value of this
NumericChromosome
at theindex
0. - floatValue() - Method in interface io.jenetics.NumericGene
-
Returns the value of the specified gene as a float.
- floatValue(int) - Method in interface io.jenetics.NumericChromosome
-
Return the float value of this
NumericChromosome
at the givenindex
. - FLOOR - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the largest (closest to positive infinity) double value that is less than or equal to the argument and is equal to a mathematical integer.
- forAll(Predicate<? super T>) - Method in interface io.jenetics.util.Seq
-
Tests whether a predicate holds for all elements of this sequence.
- forEach(Consumer<? super T>) - Method in interface io.jenetics.util.BaseSeq
- format(Cfg<?>) - Static method in class io.jenetics.ext.grammar.Bnf
-
Formats the given CFG as BNF grammar string.
- format(Tree<?, ?>) - Method in class io.jenetics.ext.util.TreeFormatter
-
Formats the given
tree
to its string representation. - format(Tree<? extends Op<Double>, ?>) - Static method in class io.jenetics.prog.op.MathExpr
-
Return the string representation of the given
tree
object. - format(Tree<V, ?>, Function<? super V, ? extends CharSequence>) - Method in class io.jenetics.ext.util.TreeFormatter
-
Formats the given
tree
to its string representation. - fromByteArray(byte[]) - Method in class io.jenetics.util.IO
-
Creates a, previously serialized, object from the given
byte[]
array. - front(BaseSeq<? extends Vec<T>>) - Static method in class io.jenetics.ext.moea.Pareto
-
Return the elements, from the given input
set
, which are part of the pareto front. - front(BaseSeq<? extends T>, Comparator<? super T>) - Static method in class io.jenetics.ext.moea.Pareto
-
Return the elements, from the given input
set
, which are part of the pareto front.
G
- GaussianMutator<G,
C> - Class in io.jenetics -
The GaussianMutator class performs the mutation of a
NumericGene
. - GaussianMutator() - Constructor for class io.jenetics.GaussianMutator
- GaussianMutator(double) - Constructor for class io.jenetics.GaussianMutator
- gene() - Method in class io.jenetics.BitChromosome
- gene() - Method in interface io.jenetics.Chromosome
-
Return the first gene of this chromosome.
- gene() - Method in class io.jenetics.Genotype
- Gene<A,
G> - Interface in io.jenetics -
Genes are the atoms of the Jenetics library.
- geneCount() - Method in class io.jenetics.Genotype
-
Return the number of genes this genotype consists of.
- generate(Cfg<? extends T>) - Method in class io.jenetics.ext.grammar.DerivationTreeGenerator
-
Generates a new derivation tree from the given grammar, cfg.
- generate(Cfg<? extends T>) - Method in interface io.jenetics.ext.grammar.Generator
-
Generates a new sentence from the given grammar.
- generate(Cfg<? extends T>) - Method in class io.jenetics.ext.grammar.SentenceGenerator
-
Generates a new sentence from the given grammar, cfg.
- generation() - Method in class io.jenetics.engine.EvolutionInit
-
Return the generation of the start population.
- generation() - Method in class io.jenetics.engine.EvolutionResult
-
The current generation.
- generation() - Method in class io.jenetics.engine.EvolutionStart
-
Return the generation of the start population.
- generation() - Method in class io.jenetics.Phenotype
-
Return the generation this
Phenotype
was created. - Generator<T,
R> - Interface in io.jenetics.ext.grammar -
Generator interface for generating sentences/derivation trees from a given grammar.
- genotype() - Method in class io.jenetics.Phenotype
-
This method returns a copy of the
Genotype
, to guarantee a immutable class. - Genotype<G> - Class in io.jenetics
-
The central class the GA is working with, is the
Genotype
. - genotypeFactory() - Method in class io.jenetics.engine.Engine.Builder
-
Return the used genotype
Factory
of the GA. - genotypeFactory() - Method in class io.jenetics.engine.Engine
-
Return the used genotype
Factory
of the GA. - genotypes() - Method in class io.jenetics.engine.EvolutionResult
-
Return the current list of genotypes of this evolution result.
- get() - Method in class io.jenetics.prog.op.EphemeralConst
-
Return a newly created, uninitialized constant of type
T
. - get() - Method in interface io.jenetics.prog.op.Op
-
Return
this
operation, or a new instance from the same type, if the operation needs to maintain internal state. - get() - Method in class io.jenetics.util.Ordered
-
Return the wrapped value.
- get(int) - Method in class io.jenetics.AbstractChromosome
- get(int) - Method in class io.jenetics.BitChromosome
- get(int) - Method in class io.jenetics.ext.util.Tree.Path
-
Return the child index at the given index (child level).
- get(int) - Method in class io.jenetics.Genotype
-
Return the chromosome at the given index.
- get(int) - Method in interface io.jenetics.util.BaseSeq
-
Return the value at the given
index
. - getZone() - Method in class io.jenetics.util.NanoClock
- GT - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns +1.0 if its first argument is greater than its second argument and returns -1.0 otherwise.
H
- hashCode() - Method in class io.jenetics.DoubleChromosome
- hashCode() - Method in class io.jenetics.IntegerChromosome
- hashCode() - Method in class io.jenetics.LongChromosome
- hashCode() - Method in class io.jenetics.AbstractChromosome
- hashCode() - Method in record class io.jenetics.AltererResult
-
Returns a hash code value for this object.
- hashCode() - Method in class io.jenetics.AnyGene
- hashCode() - Method in class io.jenetics.BitChromosome
- hashCode() - Method in class io.jenetics.CharacterChromosome
- hashCode() - Method in class io.jenetics.CharacterGene
- hashCode() - Method in class io.jenetics.DoubleGene
- hashCode() - Method in record class io.jenetics.engine.EvolutionDurations
-
Returns a hash code value for this object.
- hashCode() - Method in class io.jenetics.engine.EvolutionInit
- hashCode() - Method in class io.jenetics.engine.EvolutionResult
- hashCode() - Method in class io.jenetics.engine.EvolutionStart
- hashCode() - Method in class io.jenetics.EnumGene
- hashCode() - Method in class io.jenetics.ext.AbstractTreeGene
- hashCode() - Method in class io.jenetics.ext.BigIntegerGene
- hashCode() - Method in record class io.jenetics.ext.grammar.Cfg.Expression
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.ext.grammar.Cfg
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.ext.grammar.Cfg.NonTerminal
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.ext.grammar.Cfg.Rule
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.ext.grammar.Cfg.Terminal
-
Returns a hash code value for this object.
- hashCode() - Method in class io.jenetics.ext.rewriting.TreeMatchResult
- hashCode() - Method in class io.jenetics.ext.rewriting.TreePattern
- hashCode() - Method in record class io.jenetics.ext.rewriting.TreePattern.Val
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.ext.rewriting.TreePattern.Var
-
Returns a hash code value for this object.
- hashCode() - Method in class io.jenetics.ext.rewriting.TreeRewriteRule
- hashCode() - Method in class io.jenetics.ext.rewriting.TRS
- hashCode() - Method in record class io.jenetics.ext.util.CsvSupport.ColumnIndexes
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.ext.util.CsvSupport.Quote
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.ext.util.CsvSupport.Separator
-
Returns a hash code value for this object.
- hashCode() - Method in class io.jenetics.ext.util.FlatTreeNode
- hashCode() - Method in class io.jenetics.ext.util.Tree.Path
- hashCode() - Method in class io.jenetics.ext.util.TreeNode
- hashCode() - Method in class io.jenetics.Genotype
- hashCode() - Method in class io.jenetics.IntegerGene
- hashCode() - Method in class io.jenetics.LongGene
- hashCode() - Method in record class io.jenetics.MutatorResult
-
Returns a hash code value for this object.
- hashCode() - Method in class io.jenetics.Phenotype
- hashCode() - Method in class io.jenetics.prog.op.MathExpr
- hashCode() - Method in class io.jenetics.prog.op.Program
- hashCode() - Method in class io.jenetics.prog.op.Val
- hashCode() - Method in class io.jenetics.prog.op.Var
- hashCode() - Method in record class io.jenetics.prog.regression.Sampling.Result
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.ShiftMutator.Range
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.ShuffleMutator.Range
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.stat.DoubleMoments
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.stat.DoubleSummary
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.stat.IntMoments
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.stat.IntSummary
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.stat.LongMoments
-
Returns a hash code value for this object.
- hashCode() - Method in record class io.jenetics.stat.LongSummary
-
Returns a hash code value for this object.
- hashCode() - Method in class io.jenetics.util.CharSeq
- hashCode() - Method in class io.jenetics.util.DoubleRange
- hashCode() - Method in class io.jenetics.util.IntRange
- hashCode() - Method in class io.jenetics.util.LongRange
- hashCode() - Method in class io.jenetics.util.NanoClock
- hashCode() - Method in interface io.jenetics.util.Seq
-
Returns the hash code value for this sequence.
- hashCode() - Method in class io.jenetics.AnyChromosome
- hashCode(Tree<?, ?>) - Static method in interface io.jenetics.ext.util.Tree
-
Calculates the hash code of the given tree.
- hashCode(BaseSeq<?>) - Static method in interface io.jenetics.util.Seq
-
Unified method for calculating the hash code of every
Seq
implementation. - HPRMutator<G,
C> - Class in io.jenetics.ext -
The Hybridizing PSM and RSM Operator (HPRM) constructs an offspring from a pair of parents by hybridizing two mutation operators, PSM and RSM.
- HPRMutator() - Constructor for class io.jenetics.ext.HPRMutator
-
Default constructor, with default mutation probability (
Alterer.DEFAULT_ALTER_PROBABILITY
). - HPRMutator(double) - Constructor for class io.jenetics.ext.HPRMutator
-
Constructs an alterer with a given recombination probability.
- HYPOT - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns sqrt(x2 +y2) without intermediate overflow or underflow.
I
- ID - Enum constant in enum class io.jenetics.prog.op.MathOp
-
The identity function.
- identical(Tree<?, ?>) - Method in class io.jenetics.ext.util.FlatTreeNode
- identical(Tree<?, ?>) - Method in interface io.jenetics.ext.util.Tree
-
Tests whether
this
node is the same as theother
node. - identity() - Static method in interface io.jenetics.engine.EvolutionInterceptor
-
Return an interceptor object which does nothing.
- IMP - Enum constant in enum class io.jenetics.prog.op.BoolOp
-
Implication.
- index() - Method in class io.jenetics.prog.op.Var
-
The projection index of the variable.
- indexOf(Tree<?, ?>) - Method in interface io.jenetics.ext.util.Tree
-
Returns the index of the specified child in this node's child array, or
-1
ifthis
node doesn't contain the givenchild
. - indexOf(Object) - Method in interface io.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 io.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 io.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.
- indexWhere(Predicate<? super T>) - Method in interface io.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(Predicate<? super T>, int) - Method in interface io.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(Predicate<? super T>, int, int) - Method in interface io.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. - infinite() - Static method in class io.jenetics.engine.Limits
-
Return a predicate which always return
true
. - insert(int, TreeNode<T>) - Method in class io.jenetics.ext.util.TreeNode
-
Removes the
child
from its present parent (if it has one), sets the child's parent to this node, and then adds the child to this node's child array at indexindex
. - instances() - Method in interface io.jenetics.util.Factory
-
Return a new stream of object instances, created by this factory.
- instant() - Method in class io.jenetics.util.NanoClock
- IntegerChromosome - Class in io.jenetics
-
Numeric chromosome implementation which holds 32-bit integer numbers.
- IntegerChromosome(ISeq<IntegerGene>, IntRange) - Constructor for class io.jenetics.IntegerChromosome
-
Create a new chromosome from the given
genes
and the allowed length range of the chromosome. - IntegerGene - Class in io.jenetics
-
NumericGene implementation which holds a 32-bit integer number.
- interceptor() - Method in class io.jenetics.engine.Engine.Builder
-
Return the evolution interceptor.
- interceptor() - Method in class io.jenetics.engine.Engine
-
Return the evolution interceptor.
- interceptor(EvolutionInterceptor<G, C>) - Method in class io.jenetics.engine.Engine.Builder
-
The evolution interceptor, which allows changing the evolution start and result.
- IntermediateCrossover<G,
C> - Class in io.jenetics -
This alterer takes two chromosomes (treating it as vectors) and creates a linear combination of these vectors as a result.
- IntermediateCrossover() - Constructor for class io.jenetics.IntermediateCrossover
-
Creates a new intermediate-crossover with default recombination probability (
Alterer.DEFAULT_ALTER_PROBABILITY
) and a p value of zero, which restricts the recombined chromosomes within the hypercube of the selected chromosomes (vectors). - IntermediateCrossover(double) - Constructor for class io.jenetics.IntermediateCrossover
-
Creates a new intermediate-crossover with the given recombination probability.
- IntermediateCrossover(double, double) - Constructor for class io.jenetics.IntermediateCrossover
-
Creates a new intermediate-crossover with the given recombination probability and the line-scaling factor p.
- intersect(DoubleRange) - Method in class io.jenetics.util.DoubleRange
-
Return the intersection of
this
range with theother
. - intersect(IntRange) - Method in class io.jenetics.util.IntRange
-
Return the intersection of
this
range with theother
. - intersect(LongRange) - Method in class io.jenetics.util.LongRange
-
Return the intersection of
this
range with theother
. - IntMoments - Record Class in io.jenetics.stat
-
Value objects which contains statistical moments.
- IntMoments(long, int, int, long, double, double, double, double) - Constructor for record class io.jenetics.stat.IntMoments
-
Creates an instance of a
IntMoments
record class. - IntMomentStatistics - Class in io.jenetics.stat
-
A state object for collecting statistics such as count, min, max, sum, mean, variance, skewness and kurtosis.
- IntMomentStatistics() - Constructor for class io.jenetics.stat.IntMomentStatistics
-
Create an empty moments object.
- IntRange - Class in io.jenetics.util
-
Integer range class.
- ints() - Method in class io.jenetics.util.RandomAdapter
- ints(int, int) - Method in class io.jenetics.util.RandomAdapter
- ints(long) - Method in class io.jenetics.util.RandomAdapter
- ints(long, int, int) - Method in class io.jenetics.util.RandomAdapter
- intStream() - Method in class io.jenetics.IntegerChromosome
-
Returns a sequential stream of the alleles with this chromosome as its source.
- IntSummary - Record Class in io.jenetics.stat
-
Value objects which contains statistical summary information.
- IntSummary(long, int, int, long, double) - Constructor for record class io.jenetics.stat.IntSummary
-
Creates an instance of a
IntSummary
record class. - intToDoubleArray(int[]) - Static method in class io.jenetics.util.Conversions
-
Converts the given
int[]
array
to adouble[]
array. - intToDoubleArray(int[], IntToDoubleFunction) - Static method in class io.jenetics.util.Conversions
-
Converts the given
int[]
array
to adouble[]
array. - intToDoubleArray(IntToDoubleFunction) - Static method in class io.jenetics.util.Conversions
-
Return an array mapper function which applies the given
mapper
to every array element. - intToLongArray(int[]) - Static method in class io.jenetics.util.Conversions
-
Converts the given
int[]
array
to along[]
array. - intToLongArray(int[], IntToLongFunction) - Static method in class io.jenetics.util.Conversions
-
Converts the given
int[]
array
to along[]
array. - intToLongFunction(IntToLongFunction) - Static method in class io.jenetics.util.Conversions
-
Return an array mapper function which applies the given
mapper
to every array element. - intValue() - Method in class io.jenetics.BitChromosome
-
Return the long value this BitChromosome represents.
- intValue() - Method in class io.jenetics.DoubleGene
- intValue() - Method in class io.jenetics.IntegerGene
- intValue() - Method in class io.jenetics.LongGene
- intValue() - Method in interface io.jenetics.NumericChromosome
-
Return the int value of this
NumericChromosome
at theindex
0. - intValue() - Method in interface io.jenetics.NumericGene
-
Returns the value of the specified gene as an int.
- intValue(int) - Method in interface io.jenetics.NumericChromosome
-
Return the int value of this
NumericChromosome
at the givenindex
. - invalidCount() - Method in class io.jenetics.engine.EvolutionResult
-
Return the number of invalid individuals.
- invalids() - Method in class io.jenetics.engine.EvolutionStatistics
-
Return the statistics about the invalid individuals during the evolution process.
- invert() - Method in class io.jenetics.BitChromosome
-
Invert the ones and zeros of this bit chromosome.
- InvertibleCodec<T,
G> - Interface in io.jenetics.engine - IO - Class in io.jenetics.util
-
Class for object serialization.
- IO() - Constructor for class io.jenetics.util.IO
- io.jenetics - package io.jenetics
-
This is the base package of the Jenetics library and contains all domain classes, like Gene, Chromosome or Genotype.
- io.jenetics.base - module io.jenetics.base
- io.jenetics.engine - package io.jenetics.engine
-
This package contains classes which perform the actual evolution.
- io.jenetics.ext - module io.jenetics.ext
- io.jenetics.ext - package io.jenetics.ext
-
This package contains additional genes/chromosomes and GA operators.
- io.jenetics.ext.engine - package io.jenetics.ext.engine
-
This package contains classes, which allows to concatenate evolution
Engine
s with different configurations. - io.jenetics.ext.grammar - package io.jenetics.ext.grammar
-
This package contains classes for doing Grammatical Evolution.
- io.jenetics.ext.moea - package io.jenetics.ext.moea
-
This package contains classes which allow to do multi-object optimization with Jenetics.
- io.jenetics.ext.rewriting - package io.jenetics.ext.rewriting
-
This package contains the implementation of a Tree (Term) Rewrite System.
- io.jenetics.ext.util - package io.jenetics.ext.util
-
This package contains data-structures needed by the GA specific implementations.
- io.jenetics.prog - module io.jenetics.prog
- io.jenetics.prog - package io.jenetics.prog
-
Example
- io.jenetics.prog.op - package io.jenetics.prog.op
-
Operations
- io.jenetics.prog.regression - package io.jenetics.prog.regression
- io.jenetics.stat - package io.jenetics.stat
-
This package contains additional statistics classes which are not available in the Java core library.
- io.jenetics.util - package io.jenetics.util
-
This package contains the collection classes (
Seq
,ISeq
andMSeq
) which are used in the public interfaces of theChromosome
andGenotype
. - io.jenetics.xml - module io.jenetics.xml
- io.jenetics.xml - package io.jenetics.xml
- io.jenetics.xml.stream - package io.jenetics.xml.stream
- isAncestor(Tree<?, ?>) - Method in interface io.jenetics.ext.util.Tree
-
Return
true
if the givennode
is an ancestor ofthis
node. - isChild(Tree<?, ?>) - Method in interface io.jenetics.ext.util.Tree
-
Return
true
if the givennode
is a child ofthis
node. - isDeprecated() - Method in class io.jenetics.util.RandomAdapter
- isDescendant(Tree<?, ?>) - Method in interface io.jenetics.ext.util.Tree
-
Return
true
if the givennode
is a descendant ofthis
node. - isEmpty() - Method in class io.jenetics.CharacterChromosome
- isEmpty() - Method in class io.jenetics.ext.moea.ParetoFront
- isEmpty() - Method in interface io.jenetics.ext.util.Tree
-
A tree is considered empty if it's
Tree.value()
isnull
and has no children and parent. - isEmpty() - Method in interface io.jenetics.util.BaseSeq
-
Returns
true
if this sequence contains no elements. - isEmpty() - Method in class io.jenetics.util.CharSeq
-
Test whether this character set is empty.
- ISeq<T> - Interface in io.jenetics.util
-
Immutable, ordered, fixed sized sequence.
- isEvaluated() - Method in class io.jenetics.Phenotype
-
A phenotype instance can be created with or without fitness value.
- isLeaf() - Method in interface io.jenetics.ext.util.Tree
-
Return
true
ifthis
node has no children. - isRelated(Tree<?, ?>) - Method in interface io.jenetics.ext.util.Tree
-
Returns true if and only if the given
node
is in the same tree asthis
node. - isRoot() - Method in class io.jenetics.ext.AbstractTreeGene
- isRoot() - Method in class io.jenetics.ext.util.FlatTreeNode
- isRoot() - Method in interface io.jenetics.ext.util.Tree
-
Returns
true
if this node is the root of the tree. - isSibling(Tree<?, ?>) - Method in interface io.jenetics.ext.util.Tree
-
Test if the given
node
is a sibling ofthis
node. - isSorted() - Method in interface io.jenetics.util.Seq
-
Test whether the given array is sorted in ascending order.
- isSorted(Comparator<? super T>) - Method in interface io.jenetics.util.Seq
-
Test whether the given array is sorted in ascending order.
- isTerminal() - Method in interface io.jenetics.prog.op.Op
-
Determines if the operation is a terminal operation.
- isValid() - Method in class io.jenetics.AbstractChromosome
- isValid() - Method in class io.jenetics.AnyChromosome
- isValid() - Method in class io.jenetics.AnyGene
- isValid() - Method in class io.jenetics.BitChromosome
-
Return always
true
. - isValid() - Method in enum class io.jenetics.BitGene
-
Return always
true
. - isValid() - Method in interface io.jenetics.BoundedGene
- isValid() - Method in class io.jenetics.CharacterGene
- isValid() - Method in interface io.jenetics.Chromosome
- isValid() - Method in class io.jenetics.DoubleGene
- isValid() - Method in class io.jenetics.EnumGene
- isValid() - Method in class io.jenetics.ext.AbstractTreeGene
- isValid() - Method in class io.jenetics.Genotype
-
Test if this genotype is valid.
- isValid() - Method in class io.jenetics.IntegerGene
- isValid() - Method in class io.jenetics.LongGene
- isValid() - Method in class io.jenetics.PermutationChromosome
-
Check if this chromosome represents still a valid permutation (or subset) of the given valid alleles.
- isValid() - Method in class io.jenetics.Phenotype
-
Test whether this phenotype is valid.
- isValid() - Method in class io.jenetics.prog.ProgramChromosome
- isValid() - Method in interface io.jenetics.util.Verifiable
-
Check if this object is valid.
- isValidCharacter(Character) - Method in class io.jenetics.CharacterGene
-
Test, if the given character is valid.
- iterator() - Method in class io.jenetics.ext.moea.ParetoFront
- iterator() - Method in interface io.jenetics.ext.util.Tree
-
Return an iterator that traverses the subtree rooted at
this
. - iterator() - Method in interface io.jenetics.util.BaseSeq
J
- join(Iterable<?>) - Method in class io.jenetics.ext.util.CsvSupport.ColumnJoiner
-
Joins the given CSV
columns
, using the given separator and quote character. - join(Iterable<?>) - Static method in class io.jenetics.ext.util.CsvSupport
-
Joins the given CSV
columns
to one CSV line. - join(Object[]) - Method in class io.jenetics.ext.util.CsvSupport.ColumnJoiner
-
Joins the given CSV
columns
, using the given separator and quote character. - join(Object[]) - Static method in class io.jenetics.ext.util.CsvSupport
-
Joins the given CSV
columns
to one CSV line. - join(String...) - Static method in class io.jenetics.ext.util.CsvSupport
-
Joins the given CSV
columns
to one CSV line.
K
- killCount() - Method in class io.jenetics.engine.EvolutionResult
-
Return the number of killed individuals.
- killed() - Method in class io.jenetics.engine.EvolutionStatistics
-
Return the statistics about the killed individuals during the evolution process.
- kurtosis() - Method in record class io.jenetics.stat.DoubleMoments
-
Returns the value of the
kurtosis
record component. - kurtosis() - Method in record class io.jenetics.stat.IntMoments
-
Returns the value of the
kurtosis
record component. - kurtosis() - Method in record class io.jenetics.stat.LongMoments
-
Returns the value of the
kurtosis
record component. - kurtosis() - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Return the kurtosis of values recorded, or
Double.NaN
if less than four values have been recorded. - kurtosis() - Method in class io.jenetics.stat.IntMomentStatistics
-
Return the kurtosis of values recorded, or
Double.NaN
if less than four values have been recorded. - kurtosis() - Method in class io.jenetics.stat.LongMomentStatistics
-
Return the kurtosis of values recorded, or
Double.NaN
if less than four values have been recorded.
L
- lastChild() - Method in interface io.jenetics.ext.util.Tree
-
Return the last child of
this
node, orOptional.empty()
ifthis
node has no children. - lastIndexOf(Object) - Method in interface io.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 io.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 io.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(Predicate<? super T>) - Method in interface io.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(Predicate<? super T>, int) - Method in interface io.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(Predicate<? super T>, int, int) - Method in interface io.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. - lastLeaf() - Method in interface io.jenetics.ext.util.Tree
-
Return the last leaf that is a descendant of this node; either
this
node or its last child's last leaf. - leafCount() - Method in interface io.jenetics.ext.util.Tree
-
Returns the total number of leaves that are descendants of this node.
- leaves() - Method in interface io.jenetics.ext.util.Tree
-
Return a stream of leaves that are descendants of this node.
- left() - Method in class io.jenetics.ext.rewriting.TreeRewriteRule
-
Return the rule matching pattern.
- LEFT_MOST - Enum constant in enum class io.jenetics.ext.grammar.SentenceGenerator.Expansion
-
The symbol replacement always starting from the leftmost nonterminal as described in Grammatical Evolution.
- LEFT_TO_RIGHT - Enum constant in enum class io.jenetics.ext.grammar.SentenceGenerator.Expansion
-
The symbol replacement is performed from left to right and is repeated until all non-terminal symbols have been expanded.
- length() - Method in class io.jenetics.AbstractChromosome
- length() - Method in class io.jenetics.BitChromosome
- length() - Method in interface io.jenetics.ext.moea.Vec
-
Return the number of vector elements.
- length() - Method in class io.jenetics.ext.util.Tree.Path
-
Return the path length, which is the level of the child
this
path points to. - length() - Method in class io.jenetics.Genotype
-
Getting the number of chromosomes of this genotype.
- length() - Method in interface io.jenetics.util.BaseSeq
-
Return the length of this sequence.
- length() - Method in class io.jenetics.util.CharSeq
- lengthRange() - Method in class io.jenetics.AnyChromosome
-
Return the allowed length range of the chromosome.
- lengthRange() - Method in class io.jenetics.CharacterChromosome
-
Return the allowed length range of the chromosome.
- lengthRange() - Method in class io.jenetics.DoubleChromosome
-
Return the allowed length range of the chromosome.
- lengthRange() - Method in class io.jenetics.IntegerChromosome
-
Return the allowed length range of the chromosome.
- lengthRange() - Method in class io.jenetics.LongChromosome
-
Return the allowed length range of the chromosome.
- level() - Method in interface io.jenetics.ext.util.Tree
-
Returns the number of levels above this node.
- limit(long) - Method in interface io.jenetics.engine.EvolutionStreamable
-
Return a new
EvolutionStreamable
instance where all createdEvolutionStream
s are limited to the given number of generations. - limit(Predicate<? super EvolutionResult<G, C>>) - Method in interface io.jenetics.engine.EvolutionStream
-
Returns a stream consisting of the elements of this stream, truncated when the given
proceed
predicate returnsfalse
. - limit(Supplier<? extends Predicate<? super EvolutionResult<G, C>>>) - Method in interface io.jenetics.engine.EvolutionStreamable
-
Return a new
EvolutionStreamable
instance where all createdEvolutionStream
s are limited by the given predicate. - Limits - Class in io.jenetics.engine
-
This class contains factory methods for creating predicates, which can be used for limiting the evolution stream.
- linear(double) - Static method in class io.jenetics.stat.Samplers
-
Return a new sampler for a linear distribution with the given
mean
value, when creating sample points for the range[0, 1)
. - LinearRankSelector<G,
C> - Class in io.jenetics -
In linear-ranking selection the individuals are sorted according to their fitness values.
- LinearRankSelector() - Constructor for class io.jenetics.LinearRankSelector
-
Create a new LinearRankSelector with
nminus := 0.5
. - LinearRankSelector(double) - Constructor for class io.jenetics.LinearRankSelector
-
Create a new LinearRankSelector with the given values for
nminus
. - LineCrossover<G,
C> - Class in io.jenetics -
This alterer takes two chromosomes (treating it as vectors) and creates a linear combination of these vectors as a result.
- LineCrossover() - Constructor for class io.jenetics.LineCrossover
-
Creates a new linear-crossover with default recombination probability (
Alterer.DEFAULT_ALTER_PROBABILITY
) and a p value of zero, which restricts the recombined chromosomes within the hypercube of the selected chromosomes (vectors). - LineCrossover(double) - Constructor for class io.jenetics.LineCrossover
-
Creates a new linear-crossover with the given recombination probability.
- LineCrossover(double, double) - Constructor for class io.jenetics.LineCrossover
-
Creates a new linear-crossover with the given recombination probability and the line-scaling factor p.
- LineReader() - Constructor for class io.jenetics.ext.util.CsvSupport.LineReader
-
Create a new line reader with default quote character
'"'
(CsvSupport.Quote.DEFAULT
). - LineReader(CsvSupport.Quote) - Constructor for class io.jenetics.ext.util.CsvSupport.LineReader
-
Create a new line-reader with the given
quote
character, which is used in the CSV file which is read. - lines(Reader) - Static method in class io.jenetics.ext.util.CsvSupport
-
Splits the CSV file, given by the
reader
, into aStream
of CSV lines. - LineSplitter() - Constructor for class io.jenetics.ext.util.CsvSupport.LineSplitter
-
Create a new line splitter with default values.
- LineSplitter(CsvSupport.ColumnIndexes) - Constructor for class io.jenetics.ext.util.CsvSupport.LineSplitter
-
Create a new line splitter with the given parameters.
- LineSplitter(CsvSupport.Quote) - Constructor for class io.jenetics.ext.util.CsvSupport.LineSplitter
-
Create a new line splitter with the given parameters.
- LineSplitter(CsvSupport.Separator) - Constructor for class io.jenetics.ext.util.CsvSupport.LineSplitter
-
Create a new line splitter with the given parameters.
- LineSplitter(CsvSupport.Separator, CsvSupport.Quote) - Constructor for class io.jenetics.ext.util.CsvSupport.LineSplitter
-
Create a new line splitter with the given parameters.
- LineSplitter(CsvSupport.Separator, CsvSupport.Quote, CsvSupport.ColumnIndexes) - Constructor for class io.jenetics.ext.util.CsvSupport.LineSplitter
-
Create a new line splitter with the given parameters.
- LISP - Static variable in class io.jenetics.ext.util.TreeFormatter
-
Formats a given tree to a lisp string representation.
- listIterator() - Method in interface io.jenetics.util.BaseSeq
-
Returns a list iterator over the elements in this sequence (in proper order).
- listIterator() - Method in interface io.jenetics.util.MSeq
-
Returns a list iterator over the elements in this sequence (in a proper sequence).
- LOG - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the natural logarithm (base e) of a double value.
- LOG10 - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the base 10 logarithm of a double value.
- LongChromosome - Class in io.jenetics
-
Numeric chromosome implementation which holds 64-bit integer numbers.
- LongChromosome(ISeq<LongGene>, IntRange) - Constructor for class io.jenetics.LongChromosome
-
Create a new chromosome from the given
genes
and the allowed length range of the chromosome. - LongGene - Class in io.jenetics
-
NumericGene implementation which holds a 64-bit integer number.
- LongMoments - Record Class in io.jenetics.stat
-
Value objects which contains statistical moments.
- LongMoments(long, long, long, long, double, double, double, double) - Constructor for record class io.jenetics.stat.LongMoments
-
Creates an instance of a
LongMoments
record class. - LongMomentStatistics - Class in io.jenetics.stat
-
A state object for collecting statistics such as count, min, max, sum, mean, variance, skewness and kurtosis.
- LongMomentStatistics() - Constructor for class io.jenetics.stat.LongMomentStatistics
-
Create an empty moments object.
- LongRange - Class in io.jenetics.util
-
Long range class.
- longs() - Method in class io.jenetics.util.RandomAdapter
- longs(long) - Method in class io.jenetics.util.RandomAdapter
- longs(long, long) - Method in class io.jenetics.util.RandomAdapter
- longs(long, long, long) - Method in class io.jenetics.util.RandomAdapter
- longStream() - Method in class io.jenetics.LongChromosome
-
Returns a sequential stream of the alleles with this chromosome as its source.
- LongSummary - Record Class in io.jenetics.stat
-
Value objects which contains statistical summary information.
- LongSummary(long, long, long, long, double) - Constructor for record class io.jenetics.stat.LongSummary
-
Creates an instance of a
LongSummary
record class. - longToDoubleArray(long[]) - Static method in class io.jenetics.util.Conversions
-
Converts the given
long[]
array
to adouble[]
array. - longToDoubleArray(long[], LongToDoubleFunction) - Static method in class io.jenetics.util.Conversions
-
Converts the given
long[]
array
to adouble[]
array. - longToDoubleArray(LongToDoubleFunction) - Static method in class io.jenetics.util.Conversions
-
Return an array mapper function which applies the given
mapper
to every array element. - longToIntArray(long[]) - Static method in class io.jenetics.util.Conversions
-
Converts the given
long[]
array
to aint[]
array. - longToIntArray(long[], LongToIntFunction) - Static method in class io.jenetics.util.Conversions
-
Converts the given
long[]
array
to aint[]
array. - longToIntArray(LongToIntFunction) - Static method in class io.jenetics.util.Conversions
-
Return an array mapper function which applies the given
mapper
to every array element. - longValue() - Method in class io.jenetics.BitChromosome
-
Return the long value this BitChromosome represents.
- longValue() - Method in class io.jenetics.DoubleGene
- longValue() - Method in class io.jenetics.IntegerGene
- longValue() - Method in class io.jenetics.LongGene
- longValue() - Method in interface io.jenetics.NumericChromosome
-
Return the long value of this
NumericChromosome
at theindex
0. - longValue() - Method in interface io.jenetics.NumericGene
-
Returns the value of the specified gene as a long.
- longValue(int) - Method in interface io.jenetics.NumericChromosome
-
Return the long value of this
NumericChromosome
at the givenindex
. - LossFunction<T> - Interface in io.jenetics.prog.regression
-
This function evaluates how well an evolved program tree fits the given sample data set.
M
- mae(Double[], Double[]) - Static method in interface io.jenetics.prog.regression.LossFunction
-
Mean absolute error is measured as the average of sum of absolute differences between predictions and actual observations.
- map(Function<? super B, ? extends T>) - Method in interface io.jenetics.xml.stream.Writer
-
Maps this writer to a different base type.
- map(Function<? super char[], char[]>) - Method in class io.jenetics.CharacterChromosome
-
Maps the gene alleles of this chromosome, given as
char[]
array, by applying the given mapper functionf
. - map(Function<? super double[], double[]>) - Method in class io.jenetics.DoubleChromosome
-
Maps the gene alleles of this chromosome, given as
double[]
array, by applying the given mapper functionf
. - map(Function<? super int[], int[]>) - Method in class io.jenetics.IntegerChromosome
-
Maps the gene alleles of this chromosome, given as
int[]
array, by applying the given mapper functionf
. - map(Function<? super Cfg.Terminal<T>, ? extends A>) - Method in record class io.jenetics.ext.grammar.Cfg
-
Maps the values of the terminal symbols from type
T
to typeA
. - map(Function<? super FlatTreeNode<V>, ? extends B>) - Method in class io.jenetics.ext.util.FlatTreeNode
-
Return a sequence of all mapped nodes of the whole underlying tree.
- map(Function<? super BitSet, ? extends BitSet>) - Method in class io.jenetics.BitChromosome
-
Maps the gene alleles of this chromosome, given as
BitSet
, by applying the given mapper functionf
. - map(Function<? super long[], long[]>) - Method in class io.jenetics.LongChromosome
-
Maps the gene alleles of this chromosome, given as
long[]
array, by applying the given mapper functionf
. - map(Function<? super R, ? extends R1>) - Method in interface io.jenetics.ext.grammar.Generator
-
Maps the generated result from type
R
to typeR1
. - map(Function<? super T, ? extends B>) - Method in interface io.jenetics.engine.Codec
-
Create a new
Codec
with the mapped result type. - map(Function<? super T, ? extends B>) - Method in class io.jenetics.ext.util.TreeNode
-
Returns a new
TreeNode
consisting of all nodes ofthis
tree, but with a different value type, created by applying the given function to the node values ofthis
tree. - map(Function<? super T, ? extends B>) - Method in interface io.jenetics.util.ISeq
- map(Function<? super T, ? extends B>) - Method in interface io.jenetics.util.MSeq
- map(Function<? super T, ? extends B>) - Method in interface io.jenetics.util.Seq
-
Builds a new sequence by applying a function to all elements of this sequence.
- map(Function<? super T, ? extends B>) - Method in class io.jenetics.xml.stream.Reader
-
Create a new reader for the new mapped type
B
. - map(Function<? super T, ? extends B>, Function<? super B, ? extends T>) - Method in interface io.jenetics.engine.InvertibleCodec
-
Create a new
InvertibleCodec
with the mapped result type. - map(Function<? super T, ? extends V>) - Method in interface io.jenetics.ext.moea.ElementComparator
-
Return an element comparator for the mapped type
T
. - map(Function<? super T, ? extends V>) - Method in interface io.jenetics.ext.moea.ElementDistance
-
Return an element distance function for the mapped type
T
. - map(Function<? super V, ? extends B>) - Method in interface io.jenetics.ext.rewriting.TreePattern.Decl
-
Returns a new
TreePattern.Decl
object with the mapped typeB
. - map(Function<? super V, ? extends B>) - Method in class io.jenetics.ext.rewriting.TreePattern
-
Maps
this
tree-pattern from typeV
to typeB
. - map(Function<? super V, ? extends B>) - Method in record class io.jenetics.ext.rewriting.TreePattern.Val
- map(Function<? super V, ? extends B>) - Method in record class io.jenetics.ext.rewriting.TreePattern.Var
- map(Function<? super V, ? extends B>) - Method in class io.jenetics.ext.rewriting.TreeRewriteRule
-
Maps
this
rewrite rule from typeV
to typeB
. - map(Function<? super V, ? extends B>) - Method in class io.jenetics.ext.rewriting.TRS
-
Maps
this
TRS from typeV
to typeB
. - Mappers - Class in io.jenetics.ext.grammar
-
This class defines factories for different CFG ↔ Chromosome mappings (encodings).
- match(Tree<V, ?>) - Method in class io.jenetics.ext.rewriting.TreePattern
-
Try to match the given
tree
againstthis
pattern. - matcher(Tree<V, ?>) - Method in class io.jenetics.ext.rewriting.TreePattern
-
Creates a matcher that will match the given input tree against
this
pattern. - matches() - Method in class io.jenetics.ext.rewriting.TreeMatcher
-
Tests if the tree matches the pattern.
- matches(Tree<V, ?>) - Method in class io.jenetics.ext.rewriting.TreePattern
-
Tests whether the given input
tree
matchesthis
pattern. - MathExpr - Class in io.jenetics.prog.op
-
Contains methods for parsing mathematical expression.
- MathExpr(Tree<? extends Op<Double>, ?>) - Constructor for class io.jenetics.prog.op.MathExpr
-
Create a new
MathExpr
object from the given operation tree. - MathOp - Enum Class in io.jenetics.prog.op
-
This class contains operations for performing basic numeric operations.
- MathRewriteAlterer<G,
C> - Class in io.jenetics.prog -
Prunes a given mathematical tree with the given alterer probability.
- MathRewriteAlterer() - Constructor for class io.jenetics.prog.MathRewriteAlterer
-
Create a new alterer with the default math rewriter
MathExpr.REWRITER
and given rewrite. - MathRewriteAlterer(double) - Constructor for class io.jenetics.prog.MathRewriteAlterer
-
Create a new alterer with the default math rewriter
MathExpr.REWRITER
and given rewrite. - MathRewriteAlterer(TreeRewriter<Op<Double>>) - Constructor for class io.jenetics.prog.MathRewriteAlterer
-
Create a new alterer with the given
rewriter
. - MathRewriteAlterer(TreeRewriter<Op<Double>>, double) - Constructor for class io.jenetics.prog.MathRewriteAlterer
-
Create a new alterer with the given
rewriter
and given rewritelimit
. - MathRewriteAlterer(TreeRewriter<Op<Double>>, int, double) - Constructor for class io.jenetics.prog.MathRewriteAlterer
-
Create a new alterer with the given
rewriter
and given rewritelimit
. - max() - Method in class io.jenetics.DoubleChromosome
- max() - Method in class io.jenetics.IntegerChromosome
- max() - Method in class io.jenetics.LongChromosome
- max() - Method in interface io.jenetics.BoundedChromosome
-
Return the maximum value of this
BoundedChromosome
. - max() - Method in interface io.jenetics.BoundedGene
-
Return the allowed max value.
- max() - Method in class io.jenetics.DoubleGene
- max() - Method in class io.jenetics.ext.BigIntegerChromosome
- max() - Method in class io.jenetics.ext.BigIntegerGene
- max() - Method in class io.jenetics.IntegerGene
- max() - Method in class io.jenetics.LongGene
- max() - Method in record class io.jenetics.stat.DoubleMoments
-
Returns the value of the
max
record component. - max() - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Return the maximum value recorded, or
Double.NEGATIVE_INFINITY
if no values have been recorded. - max() - Method in record class io.jenetics.stat.DoubleSummary
-
Returns the value of the
max
record component. - max() - Method in record class io.jenetics.stat.IntMoments
-
Returns the value of the
max
record component. - max() - Method in class io.jenetics.stat.IntMomentStatistics
-
Return the maximum value recorded, or
Integer.MIN_VALUE
if no values have been recorded. - max() - Method in record class io.jenetics.stat.IntSummary
-
Returns the value of the
max
record component. - max() - Method in record class io.jenetics.stat.LongMoments
-
Returns the value of the
max
record component. - max() - Method in class io.jenetics.stat.LongMomentStatistics
-
Return the maximum value recorded, or
Long.MIN_VALUE
if no values have been recorded. - max() - Method in record class io.jenetics.stat.LongSummary
-
Returns the value of the
max
record component. - max() - Method in class io.jenetics.stat.MinMax
-
Return the current maximal object or
null
if no element has been accepted yet. - max() - Method in class io.jenetics.util.DoubleRange
-
Return the maximum value of the double range.
- max() - Method in class io.jenetics.util.IntRange
-
Return the maximum value of the integer range.
- max() - Method in class io.jenetics.util.LongRange
-
Return the maximum value of the long range.
- max(double[]) - Static method in record class io.jenetics.stat.DoubleSummary
-
Return the maximum value of the given double array.
- max(int[]) - Static method in record class io.jenetics.stat.IntSummary
-
Return the maximum value of the given double array.
- max(long[]) - Static method in record class io.jenetics.stat.LongSummary
-
Return the maximum value of the given double array.
- max(G) - Method in interface io.jenetics.BoundedGene
-
Return the maximum value of
this
and the givenother
value. - max(Comparator<? super T>, T, T) - Static method in class io.jenetics.stat.MinMax
-
Return the maximum of two values, according the given comparator.
- MAX - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Return the maximum of two values This operation has arity 2.
- maximalPhenotypeAge() - Method in class io.jenetics.engine.Engine.Builder
-
Return the maximal allowed phenotype age.
- maximalPhenotypeAge() - Method in class io.jenetics.engine.Engine
-
Return the maximal allowed phenotype age.
- maximalPhenotypeAge() - Method in class io.jenetics.engine.EvolutionParams.Builder
-
Return the maximal allowed phenotype age.
- maximalPhenotypeAge() - Method in class io.jenetics.engine.EvolutionParams
-
Return the maximal allowed phenotype age.
- maximalPhenotypeAge(long) - Method in class io.jenetics.engine.Engine.Builder
-
The maximal allowed age of a phenotype.
- maximalPhenotypeAge(long) - Method in class io.jenetics.engine.EvolutionParams.Builder
-
The maximal allowed age of a phenotype.
- maximizing() - Method in class io.jenetics.engine.Engine.Builder
-
Set to a fitness-maximizing strategy.
- MAXIMUM - Enum constant in enum class io.jenetics.Optimize
-
GA maximization
- mean() - Method in record class io.jenetics.stat.DoubleMoments
-
Returns the value of the
mean
record component. - mean() - Method in record class io.jenetics.stat.DoubleSummary
-
Returns the value of the
mean
record component. - mean() - Method in record class io.jenetics.stat.IntMoments
-
Returns the value of the
mean
record component. - mean() - Method in record class io.jenetics.stat.IntSummary
-
Returns the value of the
mean
record component. - mean() - Method in record class io.jenetics.stat.LongMoments
-
Returns the value of the
mean
record component. - mean() - Method in record class io.jenetics.stat.LongSummary
-
Returns the value of the
mean
record component. - mean() - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Return the arithmetic mean of values recorded, or
Double.NaN
if no values have been recorded. - mean() - Method in class io.jenetics.stat.IntMomentStatistics
-
Return the arithmetic mean of values recorded, or
Double.NaN
if no values have been recorded. - mean() - Method in class io.jenetics.stat.LongMomentStatistics
-
Return the arithmetic mean of values recorded, or
Double.NaN
if no values have been recorded. - mean(double[]) - Static method in record class io.jenetics.stat.DoubleSummary
-
Returns a double describing the arithmetic mean of the values, or
Double.NaN
if thevalues
array is empty. - mean(int[]) - Static method in record class io.jenetics.stat.IntSummary
-
Returns a double describing the arithmetic mean of the values, or
Double.NaN
if thevalues
array is empty. - mean(long[]) - Static method in record class io.jenetics.stat.LongSummary
-
Returns a double describing the arithmetic mean of the values, or
Double.NaN
if thevalues
array is empty. - mean(DoubleGene) - Method in class io.jenetics.DoubleGene
- mean(BigIntegerGene) - Method in class io.jenetics.ext.BigIntegerGene
- mean(IntegerGene) - Method in class io.jenetics.IntegerGene
- mean(LongGene) - Method in class io.jenetics.LongGene
- mean(T) - Method in interface io.jenetics.util.Mean
-
Return the (usually arithmetic) mean value of
this
andthat
. - Mean<T> - Interface in io.jenetics.util
-
A mixin interface for genes which can have a mean value.
- MeanAlterer<G,
C> - Class in io.jenetics -
Alters a chromosome by replacing two genes by its mean value.
- MeanAlterer() - Constructor for class io.jenetics.MeanAlterer
-
Create a new alterer with alter probability of
0.05
. - MeanAlterer(double) - Constructor for class io.jenetics.MeanAlterer
-
Constructs an alterer with a given recombination probability.
- merge(ParetoFront<? extends T>) - Method in class io.jenetics.ext.moea.ParetoFront
-
Add the all
elements
tothis
pareto-set. - millis() - Method in class io.jenetics.util.NanoClock
- min() - Method in class io.jenetics.DoubleChromosome
- min() - Method in class io.jenetics.IntegerChromosome
- min() - Method in class io.jenetics.LongChromosome
- min() - Method in interface io.jenetics.BoundedChromosome
-
Return the minimum value of this
BoundedChromosome
. - min() - Method in interface io.jenetics.BoundedGene
-
Return the allowed min value.
- min() - Method in class io.jenetics.DoubleGene
- min() - Method in class io.jenetics.ext.BigIntegerChromosome
- min() - Method in class io.jenetics.ext.BigIntegerGene
- min() - Method in class io.jenetics.IntegerGene
- min() - Method in class io.jenetics.LongGene
- min() - Method in record class io.jenetics.stat.DoubleMoments
-
Returns the value of the
min
record component. - min() - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Return the minimum value recorded, or
Double.POSITIVE_INFINITY
if no values have been recorded. - min() - Method in record class io.jenetics.stat.DoubleSummary
-
Returns the value of the
min
record component. - min() - Method in record class io.jenetics.stat.IntMoments
-
Returns the value of the
min
record component. - min() - Method in class io.jenetics.stat.IntMomentStatistics
-
Return the minimum value recorded, or
Integer.MAX_VALUE
if no values have been recorded. - min() - Method in record class io.jenetics.stat.IntSummary
-
Returns the value of the
min
record component. - min() - Method in record class io.jenetics.stat.LongMoments
-
Returns the value of the
min
record component. - min() - Method in class io.jenetics.stat.LongMomentStatistics
-
Return the minimum value recorded, or
Long.MAX_VALUE
if no values have been recorded. - min() - Method in record class io.jenetics.stat.LongSummary
-
Returns the value of the
min
record component. - min() - Method in class io.jenetics.stat.MinMax
-
Return the current minimal object or
null
if no element has been accepted yet. - min() - Method in class io.jenetics.util.DoubleRange
-
Return the minimum value of the double range.
- min() - Method in class io.jenetics.util.IntRange
-
Return the minimum value of the integer range.
- min() - Method in class io.jenetics.util.LongRange
-
Return the minimum value of the long range.
- min(double[]) - Static method in record class io.jenetics.stat.DoubleSummary
-
Return the minimum value of the given double array.
- min(int[]) - Static method in record class io.jenetics.stat.IntSummary
-
Return the minimum value of the given double array.
- min(long[]) - Static method in record class io.jenetics.stat.LongSummary
-
Return the minimum value of the given double array.
- min(G) - Method in interface io.jenetics.BoundedGene
-
Return the minimum value of
this
and the givenother
value. - min(Comparator<? super T>, T, T) - Static method in class io.jenetics.stat.MinMax
-
Return the minimum of two values, according the given comparator.
- MIN - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Return the minimum of two values.
- minimizing() - Method in class io.jenetics.engine.Engine.Builder
-
Set to a fitness minimizing strategy.
- MINIMUM - Enum constant in enum class io.jenetics.Optimize
-
GA minimization
- MinMax<C> - Class in io.jenetics.stat
-
This consumer class is used for calculating the min and max value according to the given
Comparator
. - MLEvolutionStrategy<G,
C> - Class in io.jenetics.ext -
Setup for a (μ, λ)-Evolution Strategy.
- MLEvolutionStrategy(int, int) - Constructor for class io.jenetics.ext.MLEvolutionStrategy
-
Create a new (μ, λ)-Evolution Strategy with the given parameters.
- MLEvolutionStrategy(int, int, double) - Constructor for class io.jenetics.ext.MLEvolutionStrategy
-
Create a new (μ, λ)-Evolution Strategy with the given parameters.
- MOD - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the modulo of its arguments.
- MOEA - Class in io.jenetics.ext.moea
-
Collectors for collecting final pareto-set for multi-objective optimization.
- MonteCarloSelector<G,
C> - Class in io.jenetics -
The Monte Carlo selector selects the individuals from a given population randomly.
- MonteCarloSelector() - Constructor for class io.jenetics.MonteCarloSelector
- MpLEvolutionStrategy<G,
C> - Class in io.jenetics.ext -
Setup for a (μ + λ)-Evolution Strategy.
- MpLEvolutionStrategy(int, int) - Constructor for class io.jenetics.ext.MpLEvolutionStrategy
-
Create a new (μ + λ)-Evolution Strategy with the given parameters.
- MpLEvolutionStrategy(int, int, double) - Constructor for class io.jenetics.ext.MpLEvolutionStrategy
-
Create a new (μ + λ)-Evolution Strategy with the given parameters.
- mse(Double[], Double[]) - Static method in interface io.jenetics.prog.regression.LossFunction
-
Mean square error is measured as the average of squared difference between predictions and actual observations.
- MSeq<T> - Interface in io.jenetics.util
-
Mutable, ordered, fixed sized sequence.
- MUL - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the product of its arguments.
- multiIntegerChromosomeMapper(Cfg<? extends T>, Function<? super Cfg.Rule<?>, IntRange>, Function<? super SymbolIndex, ? extends Generator<T, R>>) - Static method in class io.jenetics.ext.grammar.Mappers
-
Codec for creating results from a given grammar.
- MultiPointCrossover<G,
C> - Class in io.jenetics -
Multiple point crossover
- MultiPointCrossover() - Constructor for class io.jenetics.MultiPointCrossover
-
Create a new crossover instance with two crossover points and crossover probability 0.05.
- MultiPointCrossover(double) - Constructor for class io.jenetics.MultiPointCrossover
-
Create a new crossover instance with two crossover points.
- MultiPointCrossover(double, int) - Constructor for class io.jenetics.MultiPointCrossover
-
Create a new crossover instance.
- MultiPointCrossover(int) - Constructor for class io.jenetics.MultiPointCrossover
-
Create a new crossover instance with default crossover probability of 0.05.
- mutate(G, RandomGenerator) - Method in class io.jenetics.GaussianMutator
- mutate(G, RandomGenerator) - Method in class io.jenetics.Mutator
-
Mutates the given gene.
- mutate(Chromosome<G>, double, RandomGenerator) - Method in class io.jenetics.ext.HPRMutator
- mutate(Chromosome<G>, double, RandomGenerator) - Method in class io.jenetics.ext.RSMutator
- mutate(Chromosome<G>, double, RandomGenerator) - Method in class io.jenetics.ext.TreeMutator
-
Mutates the given chromosome.
- mutate(Chromosome<G>, double, RandomGenerator) - Method in class io.jenetics.Mutator
-
Mutates the given chromosome.
- mutate(Chromosome<G>, double, RandomGenerator) - Method in class io.jenetics.ShiftMutator
-
Splits the values between two points into two sequences and shifts the second one in front of the first one.
- mutate(Chromosome<G>, double, RandomGenerator) - Method in class io.jenetics.ShuffleMutator
-
Changes the order of the genes between two points randomly.
- mutate(Chromosome<G>, double, RandomGenerator) - Method in class io.jenetics.SwapMutator
-
Swaps the genes in the given array, with the mutation probability of this mutation.
- mutate(TreeNode<A>) - Method in class io.jenetics.ext.TreeMutator
-
This method does the actual mutating, in place.
- mutate(TreeNode<A>) - Method in class io.jenetics.ext.TreeRewriteAlterer
-
Performs the actual tree rewriting.
- mutate(Genotype<G>, double, RandomGenerator) - Method in class io.jenetics.ext.WeaselMutator
- mutate(Genotype<G>, double, RandomGenerator) - Method in class io.jenetics.Mutator
-
Mutates the given genotype.
- mutate(Phenotype<G, C>, long, double, RandomGenerator) - Method in class io.jenetics.Mutator
-
Mutates the given phenotype.
- mutations() - Method in record class io.jenetics.MutatorResult
-
Returns the value of the
mutations
record component. - Mutator<G,
C> - Class in io.jenetics -
This class is for mutating the chromosomes of a given population.
- Mutator() - Constructor for class io.jenetics.Mutator
-
Default constructor, with probability = 0.01.
- Mutator(double) - Constructor for class io.jenetics.Mutator
-
Construct a Mutation object which a given mutation probability.
- MutatorResult<T> - Record Class in io.jenetics
-
Represents the result pair of one of the four
Mutator.mutate
calls. - MutatorResult(T, int) - Constructor for record class io.jenetics.MutatorResult
-
Create a new mutation result with the given values.
N
- N(String) - Static method in record class io.jenetics.ext.grammar.Cfg
-
Factory method for creating non-terminal symbols.
- name() - Method in record class io.jenetics.ext.grammar.Cfg.NonTerminal
-
Returns the value of the
name
record component. - name() - Method in interface io.jenetics.ext.grammar.Cfg.Symbol
-
Return the name of the symbol.
- name() - Method in record class io.jenetics.ext.grammar.Cfg.Terminal
-
Returns the value of the
name
record component. - name() - Method in record class io.jenetics.ext.rewriting.TreePattern.Var
-
Returns the value of the
name
record component. - name() - Method in interface io.jenetics.prog.op.Op
-
Return the name of the operation.
- name() - Method in class io.jenetics.prog.op.Program
- name() - Method in class io.jenetics.prog.op.Val
- name() - Method in class io.jenetics.prog.op.Var
- NAMES - Static variable in enum class io.jenetics.prog.op.MathOp
-
The names of all defined operation names.
- NanoClock - Class in io.jenetics.util
-
Clock implementation with nano second precision.
- nanos() - Method in class io.jenetics.util.NanoClock
-
This returns the nanosecond-based instant, measured from 1970-01-01T00:00Z (UTC).
- NANOS_PER_SECOND - Static variable in class io.jenetics.util.NanoClock
-
These constants hold the number of nanoseconds of one second.
- NEG - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Return the negation value of a double value.
- newInstance() - Method in class io.jenetics.AnyChromosome
- newInstance() - Method in class io.jenetics.AnyGene
- newInstance() - Method in class io.jenetics.BitChromosome
- newInstance() - Method in enum class io.jenetics.BitGene
-
Create a new, random gene.
- newInstance() - Method in class io.jenetics.CharacterChromosome
-
Create a new, random chromosome.
- newInstance() - Method in class io.jenetics.CharacterGene
- newInstance() - Method in class io.jenetics.DoubleChromosome
- newInstance() - Method in class io.jenetics.DoubleGene
- newInstance() - Method in class io.jenetics.EnumGene
- newInstance() - Method in class io.jenetics.ext.BigIntegerChromosome
- newInstance() - Method in class io.jenetics.ext.BigIntegerGene
- newInstance() - Method in interface io.jenetics.Gene
-
Return a new, random gene with the same type and with the same constraints as this gene.
- newInstance() - Method in class io.jenetics.Genotype
-
Return a new, random genotype by creating new, random chromosomes (calling the
Factory.newInstance()
method) from the chromosomes of this genotype. - newInstance() - Method in class io.jenetics.IntegerChromosome
- newInstance() - Method in class io.jenetics.IntegerGene
- newInstance() - Method in class io.jenetics.LongChromosome
- newInstance() - Method in class io.jenetics.LongGene
- newInstance() - Method in class io.jenetics.PermutationChromosome
-
Create a new, random chromosome.
- newInstance() - Method in class io.jenetics.prog.ProgramChromosome
- newInstance() - Method in class io.jenetics.prog.ProgramGene
- newInstance() - Method in interface io.jenetics.util.Factory
-
Create a new instance of type T.
- newInstance(double) - Method in class io.jenetics.DoubleGene
-
Create a new gene from the given
value
and the gene context. - newInstance(int) - Method in class io.jenetics.IntegerGene
-
Create a new gene from the given
value
and the gene context. - newInstance(long) - Method in class io.jenetics.LongGene
-
Create a new gene from the given
value
and the gene context. - newInstance(A) - Method in class io.jenetics.AnyGene
- newInstance(A) - Method in interface io.jenetics.BoundedGene
-
Create a new gene from the given
value
and the current bounds. - newInstance(A) - Method in class io.jenetics.EnumGene
-
Create a new gene from the given
value
and the gene context. - newInstance(A) - Method in interface io.jenetics.Gene
-
Create a new gene from the given
value
and the gene context. - newInstance(A, int, int) - Method in interface io.jenetics.ext.TreeGene
-
Return a new tree gene with the given allele and the local tree structure.
- newInstance(FlatTree<? extends A, ?>) - Method in interface io.jenetics.ext.TreeGene
-
Return a new tree gene from the given flat tree node.
- newInstance(Op<A>) - Method in class io.jenetics.prog.ProgramGene
-
Create a new program gene with the given operation.
- newInstance(Op<A>, int, int) - Method in class io.jenetics.prog.ProgramGene
-
Return a new program gene with the given operation and the local tree structure.
- newInstance(ISeq<G>) - Method in interface io.jenetics.Chromosome
-
A factory method which creates a new
Chromosome
of specific type and the givengenes
. - newInstance(ISeq<AnyGene<A>>) - Method in class io.jenetics.AnyChromosome
- newInstance(ISeq<BitGene>) - Method in class io.jenetics.BitChromosome
- newInstance(ISeq<CharacterGene>) - Method in class io.jenetics.CharacterChromosome
- newInstance(ISeq<DoubleGene>) - Method in class io.jenetics.DoubleChromosome
- newInstance(ISeq<EnumGene<T>>) - Method in class io.jenetics.PermutationChromosome
- newInstance(ISeq<BigIntegerGene>) - Method in class io.jenetics.ext.BigIntegerChromosome
- newInstance(ISeq<IntegerGene>) - Method in class io.jenetics.IntegerChromosome
- newInstance(ISeq<LongGene>) - Method in class io.jenetics.LongChromosome
- newInstance(ISeq<ProgramGene<A>>) - Method in class io.jenetics.prog.ProgramChromosome
- newInstance(Boolean) - Method in enum class io.jenetics.BitGene
-
Create a new gene from the given
value
. - newInstance(Character) - Method in class io.jenetics.CharacterGene
-
Create a new character gene from the given character.
- newInstance(Double) - Method in class io.jenetics.DoubleGene
- newInstance(Integer) - Method in class io.jenetics.IntegerGene
- newInstance(Long) - Method in class io.jenetics.LongGene
- newInstance(Number) - Method in class io.jenetics.DoubleGene
- newInstance(Number) - Method in class io.jenetics.ext.BigIntegerGene
- newInstance(Number) - Method in class io.jenetics.IntegerGene
- newInstance(Number) - Method in class io.jenetics.LongGene
- newInstance(Number) - Method in interface io.jenetics.NumericGene
- newInstance(BigInteger) - Method in class io.jenetics.ext.BigIntegerGene
- newRange(RandomGenerator, int) - Method in interface io.jenetics.ShiftMutator.RangeRandom
-
Create a new random shift range for shifting sequences with a given
length
. - newRange(RandomGenerator, int) - Method in interface io.jenetics.ShuffleMutator.RangeRandom
-
Create a new random range for shuffling sequences with a given
length
. - newVec(T) - Method in interface io.jenetics.ext.moea.VecFactory
-
Create a new
Vec
object from the givenarray
. - next() - Method in class io.jenetics.engine.EvolutionResult
-
Return the next evolution start object with the current population and the incremented generation.
- next(Cfg.Rule<?>, int) - Method in class io.jenetics.ext.grammar.Codons
- next(Cfg.Rule<?>, int) - Method in interface io.jenetics.ext.grammar.SymbolIndex
-
Selects an index with the given upper
bound
, exclusively. - nextBoolean() - Method in class io.jenetics.util.RandomAdapter
- nextBytes(byte[]) - Method in class io.jenetics.util.RandomAdapter
- nextDouble() - Method in class io.jenetics.util.RandomAdapter
- nextDouble(double) - Method in class io.jenetics.util.RandomAdapter
- nextDouble(double, double) - Method in class io.jenetics.util.RandomAdapter
- nextExponential() - Method in class io.jenetics.util.RandomAdapter
- nextFloat() - Method in class io.jenetics.util.RandomAdapter
- nextFloat(float) - Method in class io.jenetics.util.RandomAdapter
- nextFloat(float, float) - Method in class io.jenetics.util.RandomAdapter
- nextGaussian() - Method in class io.jenetics.util.RandomAdapter
- nextGaussian(double, double) - Method in class io.jenetics.util.RandomAdapter
- nextInt() - Method in class io.jenetics.util.RandomAdapter
- nextInt(int) - Method in class io.jenetics.util.RandomAdapter
- nextInt(int, int) - Method in class io.jenetics.util.RandomAdapter
- nextLeaf() - Method in interface io.jenetics.ext.util.Tree
-
Returns the leaf after
this
node orOptional.empty()
if this node is the last leaf in the tree. - nextLong() - Method in class io.jenetics.util.RandomAdapter
- nextLong(long) - Method in class io.jenetics.util.RandomAdapter
- nextLong(long, long) - Method in class io.jenetics.util.RandomAdapter
- nextNode() - Method in interface io.jenetics.ext.util.Tree
-
Return the node that follows
this
node in a pre-order traversal ofthis
tree node. - nextSibling() - Method in interface io.jenetics.ext.util.Tree
-
Return the next sibling of
this
node in the parent's children array, ornull
ifthis
node has no parent, or it is the last child of the paren. - nonEmpty() - Method in interface io.jenetics.util.BaseSeq
-
Returns
true
if this sequence contains at least one element. - nonEvaluated() - Method in class io.jenetics.Phenotype
-
A phenotype instance can be created with or without fitness value.
- NonTerminal(String) - Constructor for record class io.jenetics.ext.grammar.Cfg.NonTerminal
-
Creates an instance of a
NonTerminal
record class. - nonTerminals() - Method in record class io.jenetics.ext.grammar.Cfg
-
Returns the value of the
nonTerminals
record component. - NOT - Enum constant in enum class io.jenetics.prog.op.BoolOp
-
Negation.
- NSGA2Selector<G,
C> - Class in io.jenetics.ext.moea -
This selector selects the first
count
elements of the population, which has been sorted by the Crowded-Comparison Operator, as described in A Fast and Elitist Multiobjective Genetic Algorithm: NSGA-II - NSGA2Selector(Comparator<? super C>, ElementComparator<? super C>, ElementDistance<? super C>, ToIntFunction<? super C>) - Constructor for class io.jenetics.ext.moea.NSGA2Selector
-
Creates a new
NSGA2Selector
with the functions needed for handling the multi-objective result typeC
. - nullifyFitness() - Method in class io.jenetics.engine.FitnessNullifier
-
Triggers the nullification of the fitness values of the population for the next generation.
- nullifyFitness() - Method in class io.jenetics.Phenotype
-
Return a phenotype, where the fitness is set to
null
. - NumericChromosome<N,
G> - Interface in io.jenetics -
Numeric chromosome interface.
- NumericGene<N,
G> - Interface in io.jenetics -
Base interface for numeric genes.
O
- object - Static variable in class io.jenetics.util.IO
-
IO implementation for "native" Java serialization.
- of() - Static method in class io.jenetics.CharacterGene
-
Create a new random character gene, chosen from the
CharacterGene.DEFAULT_CHARACTERS
. - of() - Static method in class io.jenetics.ext.util.TreeNode
-
Return a new
TreeNode
with anull
tree value. - of() - Static method in class io.jenetics.stat.MinMax
-
Create a new
MinMax
consumer. - of(boolean) - Static method in enum class io.jenetics.BitGene
-
Return the corresponding
BitGene
for the givenboolean
value. - of(char) - Static method in class io.jenetics.CharacterGene
-
Create a new character gene from the given character.
- of(char, char) - Static method in class io.jenetics.util.CharSeq
-
Expands the characters between
a
andb
. - of(char, CharSeq) - Static method in class io.jenetics.CharacterGene
-
Create a new CharacterGene from the give character.
- of(double...) - Static method in interface io.jenetics.ext.moea.Vec
-
Wraps the given array into a
Vec
object. - of(double, double) - Static method in class io.jenetics.DoubleChromosome
-
Create a new random
DoubleChromosome
of length one. - of(double, double) - Static method in class io.jenetics.DoubleGene
-
Create a new random
DoubleGene
. - of(double, double) - Static method in class io.jenetics.util.DoubleRange
-
Create a new
DoubleRange
object with the givenmin
andmax
values. - of(double, double, double) - Static method in class io.jenetics.DoubleGene
-
Create a new random
DoubleGene
with the given value and the given range. - of(double, double, int) - Static method in class io.jenetics.DoubleChromosome
-
Create a new random
DoubleChromosome
. - of(double, double, IntRange) - Static method in class io.jenetics.DoubleChromosome
-
Create a new random chromosome.
- of(double, DoubleRange) - Static method in class io.jenetics.DoubleGene
-
Create a new random
DoubleGene
with the given value and the given range. - of(int) - Static method in class io.jenetics.BitChromosome
-
Constructing a new BitChromosome with the given
length
and randomly set bits. - of(int) - Static method in class io.jenetics.CharacterChromosome
-
Create a new chromosome with the
CharacterGene.DEFAULT_CHARACTERS
char set as valid characters. - of(int) - Static method in class io.jenetics.util.IntRange
-
Return a new (half-open) range, which contains only the given value:
[value, value + 1)
. - of(int...) - Static method in interface io.jenetics.ext.moea.Vec
-
Wraps the given array into a
Vec
object. - of(int...) - Static method in class io.jenetics.ext.util.Tree.Path
-
Create a new path object from the given child indexes.
- of(int, double) - Static method in class io.jenetics.BitChromosome
-
Constructing a new BitChromosome with the given
length
and randomly set bits. - of(int, int) - Static method in class io.jenetics.IntegerChromosome
-
Create a new random
IntegerChromosome
of length one. - of(int, int) - Static method in class io.jenetics.IntegerGene
-
Create a new random
IntegerGene
. - of(int, int) - Static method in class io.jenetics.util.IntRange
-
Create a new
IntRange
object with the givenmin
andmax
values. - of(int, int, int) - Static method in class io.jenetics.IntegerChromosome
-
Create a new random
IntegerChromosome
. - of(int, int, int) - Static method in class io.jenetics.IntegerGene
-
Create a new random
IntegerGene
with the given value and the given range. - of(int, int, IntRange) - Static method in class io.jenetics.IntegerChromosome
-
Create a new random chromosome.
- of(int, A...) - Static method in class io.jenetics.EnumGene
-
Create a new enum gene from the given valid genes and the chosen allele index.
- of(int, IntRange) - Static method in class io.jenetics.IntegerGene
-
Create a new random
IntegerGene
with the given value and the given range. - of(int, ISeq<? extends A>) - Static method in class io.jenetics.EnumGene
-
Create a new enum gene from the given valid genes and the chosen allele index.
- of(int, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>) - Static method in class io.jenetics.prog.op.Program
-
Create a new, random program tree from the given (non) terminal operations with the desired depth.
- of(int, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>) - Static method in class io.jenetics.prog.ProgramChromosome
-
Create a new program chromosome with the defined depth.
- of(int, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>, RandomGenerator) - Static method in class io.jenetics.prog.op.Program
-
Create a new, random program tree from the given (non) terminal operations with the desired depth.
- of(int, Predicate<? super ProgramChromosome<A>>, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>) - Static method in class io.jenetics.prog.ProgramChromosome
-
Create a new program chromosome with the defined depth.
- of(long) - Static method in class io.jenetics.util.LongRange
-
Return a new (half-open) range, which contains only the given value:
[value, value + 1)
. - of(long...) - Static method in interface io.jenetics.ext.moea.Vec
-
Wraps the given array into a
Vec
object. - of(long, long) - Static method in class io.jenetics.LongChromosome
-
Create a new random
LongChromosome
of length one. - of(long, long) - Static method in class io.jenetics.LongGene
-
Create a new random
LongGene
. - of(long, long) - Static method in class io.jenetics.util.LongRange
-
Create a new
LongRange
object with the givenmin
andmax
values. - of(long, long, int) - Static method in class io.jenetics.LongChromosome
-
Create a new random
LongChromosome
. - of(long, long, long) - Static method in class io.jenetics.LongGene
-
Create a new random
LongGene
with the given value and the given range. - of(long, long, IntRange) - Static method in class io.jenetics.LongChromosome
-
Create a new random chromosome.
- of(long, LongRange) - Static method in class io.jenetics.LongGene
-
Create a new random
LongGene
with the given value and the given range. - of(A...) - Static method in class io.jenetics.EnumGene
-
Return a new enum gene with an allele randomly chosen from the given valid alleles.
- of(A, Supplier<? extends A>) - Static method in class io.jenetics.AnyGene
-
Create a new
AnyGene
instance with the given parameters. - of(A, Supplier<? extends A>, Predicate<? super A>) - Static method in class io.jenetics.AnyGene
-
Create a new
AnyGene
instance with the given parameters. - of(C[]) - Static method in interface io.jenetics.ext.moea.Vec
-
Wraps the given array into a
Vec
object. - of(C[], ElementDistance<C[]>) - Static method in interface io.jenetics.ext.moea.Vec
-
Wraps the given array into a
Vec
object. - of(Alterer<G, C>...) - Static method in interface io.jenetics.Alterer
-
Combine the given alterers.
- of(Alterer<G, C>, int...) - Static method in class io.jenetics.PartialAlterer
-
Wraps the given
alterer
, so that it will only work on chromosomes with the given chromosome indices. - of(Alterer<G, C>, IntRange) - Static method in class io.jenetics.PartialAlterer
-
Wraps the given
alterer
, so that it will only work on chromosomes with the given chromosome indices. - of(Chromosome<G>, Chromosome<G>...) - Static method in class io.jenetics.Genotype
-
Create a new
Genotype
from a given array ofChromosomes
. - of(DoubleGene...) - Static method in class io.jenetics.DoubleChromosome
-
Create a new
DoubleChromosome
with the given genes. - of(Codec<A, G>, Codec<B, G>, BiFunction<A, B, T>) - Static method in interface io.jenetics.engine.Codec
-
Deprecated, for removal: This API element is subject to removal in a future version.
- of(Codec<Tree<Op<T>, ?>, ProgramGene<T>>, Error<T>, Sample<T>...) - Static method in class io.jenetics.prog.regression.Regression
-
Create a new regression problem instance with the given parameters.
- of(Codec<Tree<Op<T>, ?>, ProgramGene<T>>, Error<T>, Sampling<T>) - Static method in class io.jenetics.prog.regression.Regression
-
Create a new regression problem instance with the given parameters.
- of(Codec<Tree<Op<T>, ?>, ProgramGene<T>>, Error<T>, Iterable<? extends Sample<T>>) - Static method in class io.jenetics.prog.regression.Regression
-
Create a new regression problem instance with the given parameters.
- of(EvolutionStreamable<G, C>...) - Static method in class io.jenetics.ext.engine.ConcatEngine
-
Create a new concatenating evolution engine with the given array of engines.
- of(EvolutionStreamable<G, C>...) - Static method in class io.jenetics.ext.engine.CyclicEngine
-
Create a new cycling evolution engine with the given array of
engines
. - of(InvertibleCodec<T, G>, Predicate<? super T>) - Static method in class io.jenetics.engine.RetryConstraint
-
Return a new constraint with the given
validator
and theRetryConstraint.DEFAULT_RETRY_COUNT
. - of(InvertibleCodec<T, G>, Predicate<? super T>, int) - Static method in class io.jenetics.engine.RetryConstraint
-
Return a new constraint with the given
validator
andretryLimit
. - of(InvertibleCodec<T, G>, Predicate<? super T>, Function<? super T, ? extends T>) - Static method in interface io.jenetics.engine.Constraint
-
Return a new constraint object with the given
validator
andrepairer
. - of(BigIntegerGene...) - Static method in class io.jenetics.ext.BigIntegerChromosome
-
Create a new
DoubleChromosome
with the given genes. - of(Cfg.Rule<T>...) - Static method in record class io.jenetics.ext.grammar.Cfg
-
Create a grammar object with the given rules.
- of(Tree<? extends Op<A>, ?>, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>) - Static method in class io.jenetics.prog.ProgramChromosome
-
Create a new chromosome from the given operation tree (program).
- of(Tree<? extends Op<A>, ?>, Predicate<? super ProgramChromosome<A>>, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>) - Static method in class io.jenetics.prog.ProgramChromosome
-
Create a new chromosome from the given operation tree (program).
- of(Genotype<G>, long) - Static method in class io.jenetics.Phenotype
-
Create a new phenotype from the given arguments.
- of(Genotype<G>, long, C) - Static method in class io.jenetics.Phenotype
-
Create a new phenotype from the given arguments.
- of(IntegerGene...) - Static method in class io.jenetics.IntegerChromosome
-
Create a new
IntegerChromosome
with the given genes. - of(LongGene...) - Static method in class io.jenetics.LongChromosome
-
Create a new
LongChromosome
with the given genes. - of(Optimize, ISeq<Phenotype<G, C>>, long, long, EvolutionDurations, int, int, int) - Static method in class io.jenetics.engine.EvolutionResult
-
Return a new
EvolutionResult
object with the given values. - of(Optimize, ISeq<Phenotype<G, C>>, long, EvolutionDurations, int, int, int) - Static method in class io.jenetics.engine.EvolutionResult
-
Return a new
EvolutionResult
object with the given values. - of(LossFunction<T>) - Static method in interface io.jenetics.prog.regression.Error
-
Creates an error function which only uses the given
loss
function for calculating the program error - of(LossFunction<T>, Complexity<T>) - Static method in interface io.jenetics.prog.regression.Error
-
Creates an error function by combining the given
loss
function and programcomplexity
. - of(LossFunction<T>, Complexity<T>, DoubleBinaryOperator) - Static method in interface io.jenetics.prog.regression.Error
-
Creates an error function by combining the given
loss
function and programcomplexity
. - of(Sample<? extends T>...) - Static method in interface io.jenetics.prog.regression.Sampling
-
Create a new sampling object from the given sample points.
- of(DoubleMomentStatistics) - Static method in record class io.jenetics.stat.DoubleMoments
-
Return a new value object of the statistical moments, currently represented by the
statistics
object. - of(IntMomentStatistics) - Static method in record class io.jenetics.stat.IntMoments
-
Return a new value object of the statistical moments, currently represented by the
statistics
object. - of(LongMomentStatistics) - Static method in record class io.jenetics.stat.LongMoments
-
Return a new value object of the statistical moments, currently represented by the
statistics
object. - of(Sampler) - Static method in interface io.jenetics.ShiftMutator.RangeRandom
-
Create a new random shift range generator, which uses the given distributions for creating the shift points.
- of(Sampler) - Static method in interface io.jenetics.ShuffleMutator.RangeRandom
-
Create a new random range generator, which uses the given distributions for creating the shift points.
- of(Sampler, Sampler) - Static method in interface io.jenetics.ShiftMutator.RangeRandom
-
Create a new random shift range generator, which uses the given distributions for creating the shift points.
- of(Sampler, Sampler) - Static method in interface io.jenetics.ShuffleMutator.RangeRandom
-
Create a new random range generator, which uses the given distributions for creating the range points.
- of(CharSeq) - Static method in class io.jenetics.CharacterGene
-
Create a new CharacterGene with a randomly chosen character from the set of valid characters.
- of(CharSeq, int) - Static method in class io.jenetics.CharacterChromosome
-
Create a new chromosome with the
validCharacters
char set as valid characters. - of(CharSeq, IntRange) - Static method in class io.jenetics.CharacterChromosome
-
Create a new chromosome with the
validCharacters
char set as valid characters. - of(DoubleRange) - Static method in class io.jenetics.DoubleChromosome
-
Create a new random
DoubleChromosome
of length one. - of(DoubleRange) - Static method in class io.jenetics.DoubleGene
-
Create a new random
DoubleGene
. - of(DoubleRange, int) - Static method in class io.jenetics.DoubleChromosome
-
Create a new random
DoubleChromosome
. - of(DoubleRange, IntRange) - Static method in class io.jenetics.DoubleChromosome
-
Create a new random chromosome.
- of(Factory<? extends Chromosome<G>>, int) - Static method in class io.jenetics.Genotype
-
Create a new
Genotype
which consists ofn
chromosomes, which are created by the givenfactory
. - of(Factory<Genotype<G>>) - Static method in class io.jenetics.engine.RetryConstraint
-
Return a new constraint with the given genotype factory.
- of(Factory<Genotype<G>>, Function<? super Genotype<G>, ? extends T>) - Static method in interface io.jenetics.engine.Codec
-
Create a new
Codec
object with the givenencoding
anddecoder
function. - of(Factory<Genotype<G>>, Function<? super Genotype<G>, ? extends T>, Function<? super T, Genotype<G>>) - Static method in interface io.jenetics.engine.InvertibleCodec
-
Create a new invertible codec from the given parameters.
- of(IntRange) - Static method in class io.jenetics.CharacterChromosome
-
Create a new chromosome with the
CharacterGene.DEFAULT_CHARACTERS
char set as valid characters. - of(IntRange) - Static method in class io.jenetics.IntegerChromosome
-
Create a new random
IntegerChromosome
of length one. - of(IntRange) - Static method in class io.jenetics.IntegerGene
-
Create a new random
IntegerGene
. - of(IntRange, int) - Static method in class io.jenetics.IntegerChromosome
-
Create a new random
IntegerChromosome
. - of(IntRange, IntRange) - Static method in class io.jenetics.IntegerChromosome
-
Create a new random chromosome.
- of(ISeq<? extends A>) - Static method in class io.jenetics.EnumGene
-
Return a new enum gene with an allele randomly chosen from the given valid alleles.
- of(ISeq<? extends Codec<?, G>>, Function<? super Object[], ? extends T>) - Static method in interface io.jenetics.engine.Codec
-
Deprecated, for removal: This API element is subject to removal in a future version.Will be removed in the next major version, use
Codec.combine(ISeq, Function)
instead - of(ISeq<? extends T>) - Static method in class io.jenetics.PermutationChromosome
-
Create a new, random chromosome with the given valid alleles.
- of(ISeq<? extends T>, int) - Static method in class io.jenetics.PermutationChromosome
-
Create a new, random chromosome with the given valid alleles and the desired length.
- of(ISeq<Genotype<G>>, long) - Static method in class io.jenetics.engine.EvolutionInit
-
Create a new evolution start object with the given population and for the given generation.
- of(ISeq<Phenotype<G, C>>, long) - Static method in class io.jenetics.engine.EvolutionStart
-
Create a new evolution start object with the given population and for the given generation.
- of(ISeq<ProgramGene<A>>, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>) - Static method in class io.jenetics.prog.ProgramChromosome
- of(ISeq<ProgramGene<A>>, Predicate<? super ProgramChromosome<A>>, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>) - Static method in class io.jenetics.prog.ProgramChromosome
-
Create a new program chromosome from the given (flattened) program tree.
- of(LongRange) - Static method in class io.jenetics.LongChromosome
-
Create a new random
LongChromosome
of length one. - of(LongRange) - Static method in class io.jenetics.LongGene
-
Create a new random
LongGene
. - of(LongRange, int) - Static method in class io.jenetics.LongChromosome
-
Create a new random
LongChromosome
. - of(LongRange, IntRange) - Static method in class io.jenetics.LongChromosome
-
Create a new random chromosome.
- of(Seq<? extends T>) - Static method in interface io.jenetics.util.MSeq
-
Create a new
MSeq
from the values of the givenSeq
. - of(CharSequence) - Static method in class io.jenetics.BitChromosome
-
Create a new
BitChromosome
from the given character sequence containing '0' and '1'; as created with theBitChromosome.toCanonicalString()
method. - of(CharSequence) - Static method in class io.jenetics.util.CharSeq
-
Expands the character range for the given
pattern
. - of(CharSequence, double) - Static method in class io.jenetics.BitChromosome
-
Create a new
BitChromosome
from the given character sequence containing '0' and '1'; as created with theBitChromosome.toCanonicalString()
method. - of(CharSequence, int, double) - Static method in class io.jenetics.BitChromosome
-
Create a new
BitChromosome
from the given character sequence containing '0' and '1'; as created with theBitChromosome.toCanonicalString()
method. - of(Iterable<? extends Chromosome<G>>) - Static method in class io.jenetics.Genotype
-
Create a new
Genotype
from a given array ofchromosomes
. - of(Iterable<? extends T>) - Static method in interface io.jenetics.util.ISeq
-
Create a new
ISeq
from the given values. - of(Iterable<? extends T>) - Static method in interface io.jenetics.util.MSeq
-
Create a new
MSeq
from the given values. - of(Iterable<? extends T>) - Static method in interface io.jenetics.util.Seq
-
Create a new
Seq
from the given values. - of(Iterable<DoubleGene>) - Static method in class io.jenetics.DoubleChromosome
-
Create a new
DoubleChromosome
with the given genes. - of(Iterable<IntegerGene>) - Static method in class io.jenetics.IntegerChromosome
-
Create a new
IntegerChromosome
with the given genes. - of(Iterable<LongGene>) - Static method in class io.jenetics.LongChromosome
-
Create a new
LongChromosome
with the given genes. - of(String) - Static method in class io.jenetics.CharacterChromosome
-
Create a new chromosome from the given genes (given as string).
- of(String) - Static method in record class io.jenetics.ext.grammar.Cfg.Terminal
-
Return a new terminal symbol where the name of the symbol is equal to its value.
- of(String) - Static method in class io.jenetics.prog.op.Var
-
Create a new variable with the given
name
. - of(String, int) - Static method in class io.jenetics.prog.op.Var
-
Create a new variable with the given
name
and projectionindex
. - of(String, int, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>) - Static method in class io.jenetics.prog.op.Program
-
Create a new, random program from the given (non) terminal operations with the desired depth.
- of(String, int, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>, RandomGenerator) - Static method in class io.jenetics.prog.op.Program
-
Create a new, random program from the given (non) terminal operations with the desired depth.
- of(String, int, Function<T[], T>) - Static method in interface io.jenetics.prog.op.Op
-
Create a new operation from the given parameter.
- of(String, CharSeq) - Static method in class io.jenetics.CharacterChromosome
-
Create a new chromosome from the given genes (given as string).
- of(String, BinaryOperator<T>) - Static method in interface io.jenetics.prog.op.Op
-
Create a new operation with the given name and binary operation.
- of(String, Function<? super String, ? extends V>) - Static method in interface io.jenetics.ext.rewriting.TreePattern.Decl
- of(String, Supplier<T>) - Static method in class io.jenetics.prog.op.EphemeralConst
-
Create a new ephemeral constant with the given
name
and valuesupplier
. - of(String, UnaryOperator<T>) - Static method in interface io.jenetics.prog.op.Op
-
Create a new operation with the given name and unary operation.
- of(String, T) - Static method in class io.jenetics.prog.op.Const
-
Return a new constant with the given name and value.
- of(BigInteger) - Static method in class io.jenetics.BitChromosome
-
Create a new
BitChromosome
from the given big integer value. - of(BigInteger, int) - Static method in class io.jenetics.BitChromosome
-
Create a new
BitChromosome
from the given big integer value and ones' probability. - of(BigInteger, int, double) - Static method in class io.jenetics.BitChromosome
-
Create a new
BitChromosome
from the given big integer value and ones' probability. - of(BigInteger, BigInteger) - Static method in class io.jenetics.ext.BigIntegerChromosome
-
Create a new random
DoubleChromosome
of length one. - of(BigInteger, BigInteger) - Static method in class io.jenetics.ext.BigIntegerGene
-
Create a new random
BigIntegerGene
. - of(BigInteger, BigInteger, int) - Static method in class io.jenetics.ext.BigIntegerChromosome
-
Create a new random
DoubleChromosome
. - of(BigInteger, BigInteger, BigInteger) - Static method in class io.jenetics.ext.BigIntegerGene
-
Create a new random
BigIntegerGene
with the given value and the given range. - of(BitSet) - Static method in class io.jenetics.BitChromosome
-
Constructing a new BitChromosome from a given BitSet.
- of(BitSet, int) - Static method in class io.jenetics.BitChromosome
-
Create a new
BitChromosome
with the given parameters. - of(BitSet, int, double) - Static method in class io.jenetics.BitChromosome
-
Create a new
BitChromosome
with the given parameters. - of(Comparator<? super T>) - Static method in class io.jenetics.stat.MinMax
-
Create a new
MinMax
consumer with the givenComparator
. - of(Executor) - Static method in interface io.jenetics.util.BatchExecutor
-
Create a batch executor, where the execution is forwarded to the given
executor
. - of(DoubleSummaryStatistics) - Static method in record class io.jenetics.stat.DoubleSummary
-
Return a new value object of the statistical summary, currently represented by the
statistics
object. - of(Function<? super EvolutionStart<G, C>, EvolutionStart<G, C>>, Function<? super EvolutionResult<G, C>, EvolutionResult<G, C>>) - Static method in interface io.jenetics.engine.EvolutionInterceptor
-
Create a new interceptor instance with the given
before
andafter
functions. - of(Function<T, C>, Codec<T, G>) - Static method in interface io.jenetics.engine.Problem
-
Return a new optimization problem with the given parameters.
- of(Function<T, C>, Codec<T, G>, Constraint<G, C>) - Static method in interface io.jenetics.engine.Problem
-
Return a new optimization problem with the given parameters.
- of(Predicate<? super Phenotype<G, C>>) - Static method in interface io.jenetics.engine.Constraint
-
Return a new constraint object with the given
validator
. - of(Predicate<? super Phenotype<G, C>>) - Static method in class io.jenetics.engine.RetryConstraint
-
Return a new constraint with the given
validator
and theRetryConstraint.DEFAULT_RETRY_COUNT
. - of(Predicate<? super Phenotype<G, C>>, int) - Static method in class io.jenetics.engine.RetryConstraint
-
Return a new constraint with the given
validator
andretryLimit
. - of(Predicate<? super Phenotype<G, C>>, BiFunction<? super Phenotype<G, C>, Long, Phenotype<G, C>>) - Static method in interface io.jenetics.engine.Constraint
-
Return a new constraint object with the given
validator
andrepairer
. - of(Supplier<? extends A>) - Static method in class io.jenetics.AnyChromosome
-
Create a new chromosome of type
A
with the given parameters and length one. - of(Supplier<? extends A>) - Static method in class io.jenetics.AnyGene
-
Create a new
AnyGene
instance with the given allelesupplier
. - of(Supplier<? extends A>, int) - Static method in class io.jenetics.AnyChromosome
-
Create a new chromosome of type
A
with the given parameters. - of(Supplier<? extends A>, IntRange) - Static method in class io.jenetics.AnyChromosome
-
Create a new chromosome of type
A
with the given parameters. - of(Supplier<? extends A>, Predicate<? super A>) - Static method in class io.jenetics.AnyChromosome
-
Create a new chromosome of type
A
with the given parameters and length one. - of(Supplier<? extends A>, Predicate<? super A>) - Static method in class io.jenetics.AnyGene
-
Create a new
AnyGene
instance with the given parameters. - of(Supplier<? extends A>, Predicate<? super A>, int) - Static method in class io.jenetics.AnyChromosome
-
Create a new chromosome of type
A
with the given parameters. - of(Supplier<? extends A>, Predicate<? super A>, IntRange) - Static method in class io.jenetics.AnyChromosome
-
Create a new chromosome of type
A
with the given parameters. - of(Supplier<? extends A>, Predicate<? super A>, Predicate<? super ISeq<A>>, int) - Static method in class io.jenetics.AnyChromosome
-
Create a new chromosome of type
A
with the given parameters. - of(Supplier<? extends A>, Predicate<? super A>, Predicate<? super ISeq<A>>, IntRange) - Static method in class io.jenetics.AnyChromosome
-
Create a new chromosome of type
A
with the given parameters. - of(Supplier<? extends T>, int) - Static method in interface io.jenetics.util.ISeq
-
Creates a new sequence, which is filled with objects created be the given
supplier
. - of(Supplier<? extends T>, int) - Static method in interface io.jenetics.util.MSeq
-
Creates a new sequence, which is filled with objects created be the given
supplier
. - of(Supplier<? extends T>, int) - Static method in interface io.jenetics.util.Seq
-
Creates a new sequence, which is filled with objects created be the given
supplier
. - of(Supplier<T>) - Static method in class io.jenetics.prog.op.EphemeralConst
-
Create a new ephemeral constant with the given value
supplier
. - of(IntSummaryStatistics) - Static method in record class io.jenetics.stat.IntSummary
-
Return a new value object of the statistical summary, currently represented by the
statistics
object. - of(List<? extends Sample<? extends T>>) - Static method in interface io.jenetics.prog.regression.Sampling
-
Create a new sampling object from the given sample points.
- of(List<Cfg.Rule<T>>) - Static method in record class io.jenetics.ext.grammar.Cfg
-
Create a grammar object with the given rules.
- of(LongSummaryStatistics) - Static method in record class io.jenetics.stat.LongSummary
-
Return a new value object of the statistical summary, currently represented by the
statistics
object. - of(RandomGenerator) - Static method in interface io.jenetics.ext.grammar.SymbolIndex
-
Create a new symbol-index object from the given random generator.
- of(RandomGenerator) - Static method in class io.jenetics.util.RandomAdapter
-
Create a new
Random
object from the givenrandom
generator. - of(Collector<T, ?, R>) - Static method in interface io.jenetics.util.Accumulator
-
Create a new accumulator from the given
collector
. - of(T) - Static method in class io.jenetics.ext.util.TreeNode
-
Return a new
TreeNode
with the given nodevalue
. - of(T) - Static method in class io.jenetics.prog.op.Const
-
Return a new constant with the given value.
- of(T...) - Static method in class io.jenetics.PermutationChromosome
-
Create a new, random chromosome with the given valid alleles.
- of(T[]) - Static method in interface io.jenetics.prog.regression.Sample
-
Create a new sample point from the given argument and sample result.
- of(T...) - Static method in interface io.jenetics.util.ISeq
-
Create a new
ISeq
from the given values. - of(T...) - Static method in interface io.jenetics.util.MSeq
-
Create a new
MSeq
from the given values. - of(T...) - Static method in interface io.jenetics.util.Seq
-
Create a new
Seq
from the given values. - of(T[], Comparator<? super T>, ElementDistance<T[]>) - Static method in interface io.jenetics.ext.moea.Vec
-
Wraps the given array into a
Vec
object. - of(T, Comparator<? super T>) - Static method in class io.jenetics.util.Ordered
-
Make the given
value
comparable, by using the givencomparator
. - ofAdjustableEvolution(Supplier<EvolutionStart<G, C>>, Function<? super EvolutionStart<G, C>, ? extends Evolution<G, C>>) - Static method in interface io.jenetics.engine.EvolutionStream
-
Create a new evolution stream with an adjustable evolution function.
- ofAfter(Function<? super EvolutionResult<G, C>, EvolutionResult<G, C>>) - Static method in interface io.jenetics.engine.EvolutionInterceptor
-
Create a new interceptor instance with the given
after
function. - ofBefore(Function<? super EvolutionStart<G, C>, EvolutionStart<G, C>>) - Static method in interface io.jenetics.engine.EvolutionInterceptor
-
Create a new interceptor instance with the given
before
function. - ofBitGenes(BaseSeq<BitGene>) - Static method in class io.jenetics.ext.grammar.Codons
-
Creates a new, classical codons object from the given bit-genes.
- ofComparable() - Static method in class io.jenetics.engine.EvolutionStatistics
- ofDouble(double...) - Static method in interface io.jenetics.prog.regression.Sample
-
Create a new sample point from the given argument and sample result.
- ofDouble(double, double) - Static method in interface io.jenetics.prog.regression.Sample
-
Create a new sample point from the given argument and sample result.
- ofDouble(double, double, double) - Static method in interface io.jenetics.prog.regression.Sample
-
Create a new sample point from the given argument and sample result.
- ofDouble(double, double, double, double) - Static method in interface io.jenetics.prog.regression.Sample
-
Create a new sample point from the given argument and sample result.
- ofDoubleVec() - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
double[]
vectors, where all dimensions are maximized. - ofDoubleVec(Optimize...) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
double[]
vectors. - ofDoubleVec(List<Optimize>) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
double[]
vectors. - ofEvolution(Supplier<EvolutionStart<G, C>>, Evolution<G, C>) - Static method in interface io.jenetics.engine.EvolutionStream
-
Create a new
EvolutionStream
from the givenstart
population andevolution
function. - offspringAlterDuration() - Method in record class io.jenetics.engine.EvolutionDurations
-
Returns the value of the
offspringAlterDuration
record component. - offspringFilterDuration() - Method in record class io.jenetics.engine.EvolutionDurations
-
Returns the value of the
offspringFilterDuration
record component. - offspringFraction() - Method in class io.jenetics.engine.Engine.Builder
-
Return the offspring fraction.
- offspringFraction() - Method in class io.jenetics.engine.EvolutionParams.Builder
-
Return the offspring fraction.
- offspringFraction() - Method in class io.jenetics.engine.EvolutionParams
-
Return the offspring fraction.
- offspringFraction(double) - Method in class io.jenetics.engine.Engine.Builder
-
The offspring fraction.
- offspringFraction(double) - Method in class io.jenetics.engine.EvolutionParams.Builder
-
The offspring fraction.
- offspringSelectionDuration() - Method in record class io.jenetics.engine.EvolutionDurations
-
Returns the value of the
offspringSelectionDuration
record component. - offspringSelector() - Method in class io.jenetics.engine.Engine.Builder
-
Return the used offspring
Selector
of the GA. - offspringSelector() - Method in class io.jenetics.engine.Engine
-
Return the used offspring
Selector
of the GA. - offspringSelector() - Method in class io.jenetics.engine.EvolutionParams.Builder
-
Return the used offspring
Selector
of the GA. - offspringSelector() - Method in class io.jenetics.engine.EvolutionParams
-
Return the used offspring
Selector
of the GA. - offspringSelector(Selector<G, C>) - Method in class io.jenetics.engine.Engine.Builder
-
The selector used for selecting the offspring population.
- offspringSelector(Selector<G, C>) - Method in class io.jenetics.engine.EvolutionParams.Builder
-
The selector used for selecting the offspring population.
- offspringSize() - Method in class io.jenetics.engine.Engine
-
Return the number of selected offspring.
- offspringSize() - Method in class io.jenetics.engine.EvolutionParams.Builder
-
Return the number of offspring.
- offspringSize() - Method in class io.jenetics.engine.EvolutionParams
-
Return the number of offspring.
- offspringSize(int) - Method in class io.jenetics.engine.Engine.Builder
-
The number of offspring individuals.
- ofIndex(int) - Method in interface io.jenetics.ext.moea.ElementComparator
-
Return a comparator which takes the component at the give
index
for comparison two objects of typeT
. - ofIndex(int) - Method in interface io.jenetics.ext.moea.ElementDistance
-
Return a function which calculates the distance of two vector elements at a given
index
. - ofInteger(int) - Static method in class io.jenetics.PermutationChromosome
-
Create a integer permutation chromosome with the given length.
- ofInteger(int, int) - Static method in class io.jenetics.PermutationChromosome
-
Create an integer permutation chromosome with the given range.
- ofInteger(IntRange, int) - Static method in class io.jenetics.PermutationChromosome
-
Create an integer permutation chromosome with the given range and length
- ofIntegerGenes(BaseSeq<IntegerGene>) - Static method in class io.jenetics.ext.grammar.Codons
-
Creates a new codons object from the given int-genes.
- ofIntVec() - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
int[]
vectors, where all dimensions are maximized. - ofIntVec(Optimize...) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
int[]
vectors. - ofIntVec(List<Optimize>) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
int[]
vectors. - ofLength(int) - Static method in interface io.jenetics.util.MSeq
-
Create a new
MSeq
with the givenlength
. - ofLongVec() - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
long[]
vectors, where all dimensions are maximized. - ofLongVec(Optimize...) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
long[]
vectors. - ofLongVec(List<Optimize>) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
long[]
vectors. - ofMapping(ISeq<? extends A>, ISeq<? extends B>) - Static method in class io.jenetics.engine.Codecs
-
Create a codec, which creates a mapping from the elements given in the
source
sequence to the elements given in thetarget
sequence. - ofMapping(ISeq<? extends A>, ISeq<? extends B>, Supplier<M>) - Static method in class io.jenetics.engine.Codecs
-
Create a codec, which creates a mapping from the elements given in the
source
sequence to the elements given in thetarget
sequence. - ofMatrix(DoubleRange, int, int) - Static method in class io.jenetics.engine.Codecs
-
Return a 2-dimensional matrix
InvertibleCodec
for the given range. - ofMatrix(IntRange, int, int) - Static method in class io.jenetics.engine.Codecs
-
Return a 2-dimensional matrix
InvertibleCodec
for the given range. - ofMatrix(LongRange, int, int) - Static method in class io.jenetics.engine.Codecs
-
Return a 2-dimensional matrix
InvertibleCodec
for the given range. - ofNodeCount(int) - Static method in interface io.jenetics.prog.regression.Complexity
-
Return a complexity measure which counts the number of nodes of a program.
- ofNumber() - Static method in class io.jenetics.engine.EvolutionStatistics
- ofObjectVec() - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
T[]
vectors with comparable element types. - ofObjectVec(ElementDistance<T[]>, Optimize...) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
T[]
vectors with comparable element types. - ofObjectVec(ElementDistance<T[]>, List<Optimize>) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
T[]
vectors with comparable element types. - ofObjectVec(Optimize...) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
T[]
vectors with comparable element types. - ofObjectVec(Comparator<? super T>, ElementDistance<T[]>, Optimize...) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
T[]
vectors. - ofObjectVec(Comparator<? super T>, ElementDistance<T[]>, List<Optimize>) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
T[]
vectors. - ofObjectVec(List<Optimize>) - Static method in interface io.jenetics.ext.moea.VecFactory
-
Create a new factory for
T[]
vectors with comparable element types. - ofPermutation(int) - Static method in class io.jenetics.engine.Codecs
-
Create a permutation
InvertibleCodec
of integer in the range[0, length)
. - ofPermutation(ISeq<? extends T>) - Static method in class io.jenetics.engine.Codecs
-
Create a permutation
InvertibleCodec
with the given alleles. - ofScalar(DoubleRange) - Static method in class io.jenetics.engine.Codecs
-
Return a scalar
InvertibleCodec
for the given range. - ofScalar(IntRange) - Static method in class io.jenetics.engine.Codecs
-
Return a scalar
InvertibleCodec
for the given range. - ofScalar(LongRange) - Static method in class io.jenetics.engine.Codecs
-
Return a scalar
InvertibleCodec
for the given range. - ofScalar(Supplier<? extends A>) - Static method in class io.jenetics.engine.Codecs
- ofScalar(Supplier<? extends A>, Predicate<? super A>) - Static method in class io.jenetics.engine.Codecs
- ofSubSet(ISeq<? extends T>) - Static method in class io.jenetics.engine.Codecs
-
The subset
InvertibleCodec
can be used for problems where it is required to find the best variable-sized subset from a given basic set. - ofSubSet(ISeq<? extends T>, int) - Static method in class io.jenetics.engine.Codecs
-
The subset
InvertibleCodec
can be used for problems where it is required to find the best fixed-size subset from a given basic set. - ofTree(Tree<? extends T, ?>) - Static method in class io.jenetics.ext.util.TreeNode
-
Return a new
TreeNode
from the given sourcetree
. - ofTree(Tree<? extends T, ?>, Function<? super T, ? extends B>) - Static method in class io.jenetics.ext.util.TreeNode
-
Return a new
TreeNode
from the given sourcetree
. - ofTree(Tree<? extends V, ?>) - Static method in class io.jenetics.ext.util.FlatTreeNode
-
Create a new, immutable
FlatTreeNode
from the giventree
. - ofType(Class<? extends T>) - Static method in class io.jenetics.prog.op.ConstRewriter
-
Create a new rewriter for constant operation subtrees (expressions).
- ofVec() - Static method in class io.jenetics.ext.moea.NSGA2Selector
-
Return a new selector for the given result type
V
. - ofVec() - Static method in class io.jenetics.ext.moea.UFTournamentSelector
-
Return a new selector for the given result type
V
. - ofVector(Codec<? extends S, G>, int) - Static method in class io.jenetics.engine.Codecs
-
Create a vector (
ISeq
) of domain objects, which are created with the givencodec
. - ofVector(DoubleRange...) - Static method in class io.jenetics.engine.Codecs
-
Create a vector
InvertibleCodec
for the given ranges. - ofVector(DoubleRange, int) - Static method in class io.jenetics.engine.Codecs
-
Return a vector
InvertibleCodec
for the given range. - ofVector(DoubleRange, IntRange) - Static method in class io.jenetics.engine.Codecs
-
Return a vector
InvertibleCodec
for the given range. - ofVector(IntRange...) - Static method in class io.jenetics.engine.Codecs
-
Create a vector
InvertibleCodec
for the given ranges. - ofVector(IntRange, int) - Static method in class io.jenetics.engine.Codecs
-
Return a vector
InvertibleCodec
for the given range. - ofVector(IntRange, IntRange) - Static method in class io.jenetics.engine.Codecs
-
Return a vector
InvertibleCodec
for the given range. - ofVector(LongRange...) - Static method in class io.jenetics.engine.Codecs
-
Create a vector
InvertibleCodec
for the given ranges. - ofVector(LongRange, int) - Static method in class io.jenetics.engine.Codecs
-
Return a vector
InvertibleCodec
for the given range. - ofVector(LongRange, IntRange) - Static method in class io.jenetics.engine.Codecs
-
Return a vector
InvertibleCodec
for the given range. - ofVector(Supplier<? extends A>, int) - Static method in class io.jenetics.engine.Codecs
- ofVector(Supplier<? extends A>, Predicate<? super A>, int) - Static method in class io.jenetics.engine.Codecs
- ofVector(Supplier<? extends A>, Predicate<? super A>, Predicate<? super ISeq<A>>, int) - Static method in class io.jenetics.engine.Codecs
- ofVirtualThreads() - Static method in interface io.jenetics.util.BatchExecutor
-
Return a batch executor, where each task of a given batch is executed in its own virtual thread.
- ONE - Static variable in enum class io.jenetics.BitGene
- oneProbability() - Method in class io.jenetics.BitChromosome
-
Return the one nominal probability of this chromosome.
- ones() - Method in class io.jenetics.BitChromosome
-
Return the indexes of the ones of this bit-chromosome as stream.
- Op<T> - Interface in io.jenetics.prog.op
-
Operation interface.
- operations() - Method in class io.jenetics.prog.ProgramChromosome
-
Return the allowed operations.
- operations() - Method in class io.jenetics.prog.ProgramGene
-
Return the allowed operations.
- Operations - Search tag in package io.jenetics.prog.op
- Section
- optimize() - Method in class io.jenetics.engine.Engine.Builder
-
Return the optimization strategy.
- optimize() - Method in class io.jenetics.engine.Engine
-
Return the optimization strategy.
- optimize() - Method in class io.jenetics.engine.EvolutionResult
-
Return the optimization strategy used.
- optimize(Optimize) - Method in class io.jenetics.engine.Engine.Builder
-
The optimization strategy used by the engine.
- Optimize - Enum Class in io.jenetics
-
This
enum
determines whether the GA should maximize or minimize the fitness function. - or(BitChromosome) - Method in class io.jenetics.BitChromosome
-
Returns a
BitChromosome
whose value is (this | other
). - OR - Enum constant in enum class io.jenetics.prog.op.BoolOp
-
Disjunction.
- order() - Method in class io.jenetics.Recombinator
-
Return the number of individuals involved in the
Recombinator.recombine(MSeq, int[], long)
step. - Ordered<T> - Class in io.jenetics.util
-
Object wrapper, which makes the wrapped value
Comparable
, by defining a separateComparator
.
P
- parallelStream() - Method in interface io.jenetics.util.Seq
-
Returns a possibly parallel
Stream
with this sequence as its source. - parent() - Method in class io.jenetics.ext.AbstractTreeGene
-
Return the parent node of this tree node.
- parent() - Method in class io.jenetics.ext.util.FlatTreeNode
- parent() - Method in interface io.jenetics.ext.util.Tree
-
Return the parent node of this tree node.
- parent() - Method in class io.jenetics.ext.util.TreeNode
-
Returns this node's parent if available.
- PARENTHESES - Static variable in class io.jenetics.ext.util.TreeFormatter
-
Formats a given tree to a parentheses string representation.
- Pareto - Class in io.jenetics.ext.moea
-
Low-level utility methods for doing pareto-optimal calculations.
- ParetoFront<T> - Class in io.jenetics.ext.moea
-
This class only contains non-dominate (Pareto-optimal) elements according to a given dominance measure.
- ParetoFront(Comparator<? super T>) - Constructor for class io.jenetics.ext.moea.ParetoFront
-
Create a new
ParetoSet
with the givendominance
measure. - ParetoFront(Comparator<? super T>, BiPredicate<? super T, ? super T>) - Constructor for class io.jenetics.ext.moea.ParetoFront
-
Create a new
ParetoSet
with the givendominance
measure. - parse(CharSequence) - Static method in class io.jenetics.ext.util.CsvSupport
-
Parses the given CSV string into a list of rows.
- parse(CharSequence, Function<? super String[], ? extends T>) - Static method in class io.jenetics.ext.util.CsvSupport
-
Parses the given CSV string into a list of records.
- parse(String) - Static method in class io.jenetics.ext.grammar.Bnf
-
Parses the given BNF
grammar
string to aCfg
object. - parse(String) - Static method in class io.jenetics.ext.rewriting.TreeRewriteRule
-
Compiles the string representation of a rewrite rule:
- parse(String) - Static method in class io.jenetics.ext.util.FlatTreeNode
-
Parses a (parentheses) tree string, created with
Tree.toParenthesesString()
. - parse(String) - Static method in class io.jenetics.ext.util.TreeNode
-
Parses a (parentheses) tree string, created with
Tree.toParenthesesString()
. - parse(String) - Static method in class io.jenetics.prog.op.MathExpr
-
Parses the given
expression
into an AST tree. - parse(String) - Static method in class io.jenetics.prog.op.Var
-
Parses the given variable string to its name and index.
- parse(String...) - Static method in class io.jenetics.ext.rewriting.TRS
-
Create a new TRS from the given rewrite rules.
- parse(String, Function<? super String, ? extends B>) - Static method in class io.jenetics.ext.util.FlatTreeNode
-
Parses a (parentheses) tree string, created with
Tree.toParenthesesString()
. - parse(String, Function<? super String, ? extends B>) - Static method in class io.jenetics.ext.util.TreeNode
-
Parses a (parentheses) tree string, created with
Tree.toParenthesesString()
. - parse(String, Function<? super String, ? extends V>) - Static method in class io.jenetics.ext.rewriting.TreeRewriteRule
-
Compiles the string representation of a rewrite rule:
- parse(Function<? super String, ? extends V>, String...) - Static method in class io.jenetics.ext.rewriting.TRS
-
Create a new TRS from the given rewrite rules and type mapper.
- parseDoubles(CharSequence) - Static method in class io.jenetics.ext.util.CsvSupport
-
Parses the given CSV string into a list of
double[]
array rows. - parseDoubles(CharSequence) - Static method in interface io.jenetics.prog.regression.Sample
-
Parses the given CSV string into a list of double sample points.
- parseTree(String) - Static method in class io.jenetics.prog.op.MathExpr
-
Parses the given mathematical expression string and returns the mathematical expression tree.
- PartialAlterer<G,
C> - Class in io.jenetics -
This alterer wraps a given alterer which works on a given section of the genotype's chromosomes.
- PartiallyMatchedCrossover<T,
C> - Class in io.jenetics -
The
PartiallyMatchedCrossover
(PMX) guarantees that allGene
s are found exactly once in each chromosome. - PartiallyMatchedCrossover(double) - Constructor for class io.jenetics.PartiallyMatchedCrossover
- path() - Method in interface io.jenetics.ext.util.Tree
-
Return the
Tree.Path
ofthis
tree, such thatfinal Tree<Integer, ?> tree = ...; final Tree.Path path = tree.path(); assert tree == tree.getRoot() .childAtPath(path) .orElse(null);
- pathElements() - Method in interface io.jenetics.ext.util.Tree
-
Returns the path from the root, to get to this node.
- pathFromAncestorIterator(Tree<?, ?>) - Method in interface io.jenetics.ext.util.Tree
-
Return an iterator that follows the path from
ancestor
tothis
node. - pattern() - Method in class io.jenetics.ext.rewriting.TreeMatcher
-
Return the underlying pattern of
this
matcher. - PermutationChromosome<T> - Class in io.jenetics
-
This chromosome can be used to model permutations of a given (sub) set of alleles.
- PermutationChromosome(ISeq<EnumGene<T>>) - Constructor for class io.jenetics.PermutationChromosome
-
Create a new
PermutationChromosome
from the givengenes
. - Phenotype<G,
C> - Class in io.jenetics -
The
Phenotype
consists of aGenotype
, the current generation and an optional fitness value. - phenotypeAge() - Method in class io.jenetics.engine.EvolutionStatistics
-
Return the statistics about the individual's age.
- PI - Static variable in enum class io.jenetics.prog.op.MathOp
-
The double value that is closer than any other to pi, the ratio of the circumference of a circle to its diameter.
- plus(EvolutionDurations) - Method in record class io.jenetics.engine.EvolutionDurations
-
Returns a copy of this duration with the specified duration added.
- population() - Method in record class io.jenetics.AltererResult
-
Returns the value of the
population
record component. - population() - Method in class io.jenetics.engine.EvolutionInit
-
Return the initial population.
- population() - Method in class io.jenetics.engine.EvolutionResult
-
Return the population after the evolution step.
- population() - Method in class io.jenetics.engine.EvolutionStart
-
Return the population before the evolution step.
- POPULATION_COMPARATOR - Variable in class io.jenetics.ProbabilitySelector
- populationSize() - Method in class io.jenetics.engine.Engine.Builder
-
Return the number of individuals of a population.
- populationSize() - Method in class io.jenetics.engine.Engine
-
Return the number of individuals of a population.
- populationSize() - Method in class io.jenetics.engine.EvolutionParams.Builder
-
Return the number of individuals of a population.
- populationSize() - Method in class io.jenetics.engine.EvolutionParams
-
Return the population size.
- populationSize(int) - Method in class io.jenetics.engine.Engine.Builder
-
The number of individuals which form the population.
- populationSize(int) - Method in class io.jenetics.engine.EvolutionParams.Builder
-
The number of individuals which form the population.
- postorderIterator() - Method in interface io.jenetics.ext.util.Tree
-
Return an iterator that traverses the subtree rooted at
this
node in post-order. - postorderStream() - Method in interface io.jenetics.ext.util.Tree
-
Return a stream that traverses the subtree rooted at
this
node in post-order. - POW - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the value of the first argument raised to the power of the second argument.
- preorderIterator() - Method in interface io.jenetics.ext.util.Tree
-
Return an iterator that traverses the subtree rooted at
this
node in pre-order. - preorderStream() - Method in interface io.jenetics.ext.util.Tree
-
Return a stream that traverses the subtree rooted at
this
node in pre-order. - prepend(Iterable<? extends T>) - Method in interface io.jenetics.util.ISeq
- prepend(Iterable<? extends T>) - Method in interface io.jenetics.util.MSeq
- prepend(Iterable<? extends T>) - Method in interface io.jenetics.util.Seq
-
Return a new
Seq
with the givenvalues
prepended. - prepend(T...) - Method in interface io.jenetics.util.ISeq
- prepend(T...) - Method in interface io.jenetics.util.MSeq
- prepend(T...) - Method in interface io.jenetics.util.Seq
-
Return a new
Seq
with the givenvalues
prepended. - previousLeaf() - Method in interface io.jenetics.ext.util.Tree
-
Return the leaf before
this
node ornull
ifthis
node is the first leaf in the tree. - previousNode() - Method in interface io.jenetics.ext.util.Tree
-
Return the node that precedes this node in a pre-order traversal of
this
tree node. - previousSibling() - Method in interface io.jenetics.ext.util.Tree
-
Return the previous sibling of
this
node in the parent's children list, orOptional.empty()
if this node has no parent or is the parent's first child. - probabilities(Seq<Phenotype<G, C>>, int) - Method in class io.jenetics.ExponentialRankSelector
-
This method sorts the population in descending order while calculating the selection probabilities.
- probabilities(Seq<Phenotype<G, C>>, int) - Method in class io.jenetics.LinearRankSelector
-
This method sorts the population in descending order while calculating the selection probabilities.
- probabilities(Seq<Phenotype<G, C>>, int) - Method in class io.jenetics.ProbabilitySelector
-
Return an Probability array, which corresponds to the given Population.
- probabilities(Seq<Phenotype<G, C>>, int, Optimize) - Method in class io.jenetics.ProbabilitySelector
-
This method takes the probabilities from the
ProbabilitySelector.probabilities(Seq, int)
method and inverts it if needed. - probabilities(Seq<Phenotype<G, N>>, int) - Method in class io.jenetics.BoltzmannSelector
- probabilities(Seq<Phenotype<G, N>>, int) - Method in class io.jenetics.RouletteWheelSelector
- probability() - Method in class io.jenetics.AbstractAlterer
-
Return the recombination/alter probability for this alterer.
- ProbabilitySelector<G,
C> - Class in io.jenetics -
Probability selectors are a variation of fitness proportional selectors and selects individuals from a given population based on its selection probability P(i).
- ProbabilitySelector() - Constructor for class io.jenetics.ProbabilitySelector
-
Create a new selector with
sorted = false
. - ProbabilitySelector(boolean) - Constructor for class io.jenetics.ProbabilitySelector
-
Create a new
ProbabilitySelector
with the givensorting
flag. - Problem<T,
G, - Interface in io.jenetics.engineC> -
This interface describes a problem which can be solved by the GA evolution
Engine
. - Program<T> - Class in io.jenetics.prog.op
-
This class composes a given operation tree to a new operation, which can serve as a sub program in another operation tree.
- Program(String, Tree<? extends Op<T>, ?>) - Constructor for class io.jenetics.prog.op.Program
-
Create a new program with the given name and the given operation tree.
- ProgramChromosome<A> - Class in io.jenetics.prog
-
Holds the nodes of the operation tree.
- ProgramChromosome(ISeq<ProgramGene<A>>, Predicate<? super ProgramChromosome<A>>, ISeq<? extends Op<A>>, ISeq<? extends Op<A>>) - Constructor for class io.jenetics.prog.ProgramChromosome
-
Create a new program chromosome from the given program genes.
- ProgramGene<A> - Class in io.jenetics.prog
-
This gene represents a program, build upon an AST of
Op
functions. - ProxySorter - Class in io.jenetics.util
-
This sorting methods doesn't sort a given array directly; instead, an index lookup array is returned which allows accessing the array in a sorted order.
- ProxySorter.Comparator<T> - Interface in io.jenetics.util
-
The comparator used for comparing two array elements at the specified indexes.
- publish() - Method in class io.jenetics.prog.regression.SampleBuffer
-
Making the current sample points available for the
SampleBuffer.eval(Tree)
function.
Q
- quantile() - Method in class io.jenetics.stat.Quantile
-
Return the quantile
this
object has been parametrized with. - Quantile - Class in io.jenetics.stat
-
Implementation of the quantile estimation algorithm published by
- Quantile(double) - Constructor for class io.jenetics.stat.Quantile
-
Create a new quantile accumulator with the given value.
- Quote(char) - Constructor for record class io.jenetics.ext.util.CsvSupport.Quote
-
Creates a new Quote char object.
R
- R(String, Cfg.Expression<T>...) - Static method in record class io.jenetics.ext.grammar.Cfg
-
Factory method for creating a new rule.
- random() - Static method in class io.jenetics.util.RandomRegistry
-
Return the
RandomGenerator
of the current scope. - random(Supplier<? extends R>) - Static method in class io.jenetics.util.RandomRegistry
-
Set a new
Supplier
ofRandomGenerator
for the global scope. - random(RandomGenerator) - Static method in class io.jenetics.util.RandomRegistry
-
Set a new
RandomGenerator
for the global scope. - random(RandomGeneratorFactory<? extends R>) - Static method in class io.jenetics.util.RandomRegistry
-
Set a new
RandomGeneratorFactory
for the global scope. - RandomAdapter - Class in io.jenetics.util
-
Some places in the Java API still require a
Random
object instead of the newRandomGenerator
. - RandomRegistry - Class in io.jenetics.util
-
This class holds the
RandomGenerator
engine used for the GA. - range() - Method in class io.jenetics.DoubleGene
-
Return the range of
this
gene. - range() - Method in class io.jenetics.IntegerGene
-
Return the range of
this
gene. - range() - Method in class io.jenetics.LongGene
-
Return the range of
this
gene. - Range(int, int) - Constructor for record class io.jenetics.ShuffleMutator.Range
-
Creates an instance of a
Range
record class. - Range(int, int, int) - Constructor for record class io.jenetics.ShiftMutator.Range
-
Create a new shift range with the given parameters
- rank(BaseSeq<? extends Vec<T>>) - Static method in class io.jenetics.ext.moea.Pareto
-
Calculates the non-domination rank of the given input
set
, using the natural order of the elements as dominance measure. - rank(BaseSeq<? extends T>, Comparator<? super T>) - Static method in class io.jenetics.ext.moea.Pareto
-
Calculates the non-domination rank of the given input
set
, using the givendominance
comparator. - read(File) - Method in class io.jenetics.util.IO
-
Reads an object from the given file.
- read(InputStream) - Method in class io.jenetics.util.IO
-
Reads an object from the given input stream.
- read(InputStream) - Static method in class io.jenetics.xml.Readers.BitChromosome
-
Read a new
BitChromosome
from the given input stream. - read(InputStream) - Static method in class io.jenetics.xml.Readers.CharacterChromosome
-
Read a new
CharacterChromosome
from the given input stream. - read(InputStream) - Static method in class io.jenetics.xml.Readers.DoubleChromosome
-
Read a new
DoubleChromosome
from the given input stream. - read(InputStream) - Static method in class io.jenetics.xml.Readers.IntegerChromosome
-
Read a new
IntegerChromosome
from the given input stream. - read(InputStream) - Static method in class io.jenetics.xml.Readers.LongChromosome
-
Read a new
LongChromosome
from the given input stream. - read(InputStream, Reader<? extends A>) - Static method in class io.jenetics.xml.Readers.PermutationChromosome
-
Reads a new
PermutationChromosome
from the given input stream. - read(InputStream, Reader<? extends C>) - Static method in class io.jenetics.xml.Readers.Genotype
-
Reads a genotype by using the given chromosome reader.
- read(InputStream, Reader<? extends C>) - Static method in class io.jenetics.xml.Readers.Genotypes
-
Reads the genotypes by using the given chromosome reader.
- read(InputStream, Reader<? extends C>) - Static method in class io.jenetics.xml.Readers
-
Reads the genotypes by using the given chromosome reader.
- read(Reader) - Method in class io.jenetics.ext.util.CsvSupport.LineReader
-
Reads all CSV lines from the given
reader
. - read(Class<T>, File) - Method in class io.jenetics.util.IO
-
Reads an object from the given file.
- read(Class<T>, InputStream) - Method in class io.jenetics.util.IO
-
Reads an object from the given input stream.
- read(Class<T>, String) - Method in class io.jenetics.util.IO
-
Reads an object from the given file.
- read(Class<T>, Path) - Method in class io.jenetics.util.IO
-
Reads an object from the given file.
- read(String) - Method in class io.jenetics.util.IO
-
Reads an object from the given file.
- read(Path) - Method in class io.jenetics.util.IO
-
Reads an object from the given file.
- read(XMLStreamReader) - Method in class io.jenetics.xml.stream.Reader
-
Read the given type from the underlying XML stream
reader
. - readAllLines(Reader) - Static method in class io.jenetics.ext.util.CsvSupport
-
Splits the CSV file, given by the
reader
, into aList
of CSV lines. - readAllRows(Reader) - Static method in class io.jenetics.ext.util.CsvSupport
-
Splits the CSV file, given by the
reader
, into aList
of CSV lines. - reader() - Static method in class io.jenetics.xml.Readers.BitChromosome
-
Return a XML reader for
BitChromosome
objects. - reader() - Static method in class io.jenetics.xml.Readers.CharacterChromosome
-
Return a XML reader for
CharacterChromosome
objects. - reader() - Static method in class io.jenetics.xml.Readers.DoubleChromosome
-
Return a
DoubleChromosome
reader. - reader() - Static method in class io.jenetics.xml.Readers.IntegerChromosome
-
Return a
IntegerChromosome
reader. - reader() - Static method in class io.jenetics.xml.Readers.LongChromosome
-
Return a
LongChromosome
reader. - reader(Reader<? extends A>) - Static method in class io.jenetics.xml.Readers.PermutationChromosome
-
Return a reader for permutation chromosomes with the given allele reader.
- reader(Reader<? extends C>) - Static method in class io.jenetics.xml.Readers.Genotype
-
Create a genotype reader with the given chromosome reader.
- reader(Reader<C>) - Static method in class io.jenetics.xml.Readers.Genotypes
-
Return a genotype reader using the given chromosome reader.
- reader(InputStream) - Static method in class io.jenetics.xml.stream.XML
-
Create a new XML stream reader from the given
input
stream. - reader(String, BoundedGeneCreator<A, G>, IntFunction<G[]>, Function<G[], C>, Reader<? extends A>) - Static method in class io.jenetics.xml.Readers.BoundedChromosome
-
Create a bounded chromosome reader with the given configuration.
- Reader<T> - Class in io.jenetics.xml.stream
-
XML reader class, used for reading objects in XML format.
- Readers - Class in io.jenetics.xml
-
This class contains static fields and methods, for creating chromosome- and genotype readers for different gene types.
- Readers.BitChromosome - Class in io.jenetics.xml
-
Bit chromosome reader methods, which reads XML-representations of bit-chromosomes.
- Readers.BoundedChromosome - Class in io.jenetics.xml
-
Reader methods for
BoundedChromosome
objects. - Readers.CharacterChromosome - Class in io.jenetics.xml
-
Reader methods for
CharacterChromosome
objects. - Readers.DoubleChromosome - Class in io.jenetics.xml
-
Reader methods for
DoubleChromosome
objects. - Readers.Genotype - Class in io.jenetics.xml
-
Writer methods for
Genotype
objects. - Readers.Genotypes - Class in io.jenetics.xml
-
This class contains static reader methods for
Genotype
objects. - Readers.IntegerChromosome - Class in io.jenetics.xml
-
Reader methods for
IntegerChromosome
objects. - Readers.LongChromosome - Class in io.jenetics.xml
-
Reader methods for
LongChromosome
objects. - Readers.PermutationChromosome - Class in io.jenetics.xml
-
Reader methods for
PermutationChromosome
objects. - Recombinator<G,
C> - Class in io.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 io.jenetics.Recombinator
-
Constructs an alterer with a given recombination probability.
- recombine(MSeq<Phenotype<G, C>>, int[], long) - Method in class io.jenetics.CombineAlterer
- recombine(MSeq<Phenotype<G, C>>, int[], long) - Method in class io.jenetics.Crossover
- recombine(MSeq<Phenotype<G, C>>, int[], long) - Method in class io.jenetics.ext.TreeCrossover
- recombine(MSeq<Phenotype<G, C>>, int[], long) - Method in class io.jenetics.Recombinator
-
Recombination template method.
- reduce(U[], BiFunction<? super V, ? super U[], ? extends U>) - Method in class io.jenetics.ext.util.FlatTreeNode
- reduce(U[], BiFunction<? super V, ? super U[], ? extends U>) - Method in interface io.jenetics.ext.util.Tree
-
Performs a reduction on the elements of
this
tree, using an associative reduction function. - Regression<T> - Class in io.jenetics.prog.regression
-
This class implements a symbolic regression problem.
- reindex(TreeNode<Op<V>>) - Static method in class io.jenetics.prog.op.Var
-
Re-indexes the variables of the given operation
tree
. - reindex(TreeNode<Op<V>>, Map<Var<V>, Integer>) - Static method in class io.jenetics.prog.op.Var
-
Re-indexes the variables of the given operation
tree
. - remove(int) - Method in class io.jenetics.ext.util.TreeNode
-
Removes the child at the specified index from this node's children and sets that node's parent to
null
. - remove(Tree<?, ?>) - Method in class io.jenetics.ext.util.TreeNode
-
Remove the
child
fromthis
node's child array, giving it anull
parent. - removeAllChildren() - Method in class io.jenetics.ext.util.TreeNode
-
Removes all children fo
this
node and setting their parents tonull
. - removeAtPath(Tree.Path) - Method in class io.jenetics.ext.util.TreeNode
-
Removes the child at the given
path
. - repair(Phenotype<G, C>, long) - Method in interface io.jenetics.engine.Constraint
-
Tries to repair the given phenotype.
- repair(Phenotype<G, C>, long) - Method in class io.jenetics.engine.RetryConstraint
- replace(int, TreeNode<T>) - Method in class io.jenetics.ext.util.TreeNode
-
Replaces the child at the give index with the given
child
- replaceAtPath(Tree.Path, TreeNode<T>) - Method in class io.jenetics.ext.util.TreeNode
-
Replaces the child at the given
path
with the given newchild
. - reset() - Method in class io.jenetics.stat.Quantile
-
Reset this object to its initial state.
- reset() - Static method in class io.jenetics.util.RandomRegistry
-
Set the random object to its default value.
- result() - Method in record class io.jenetics.MutatorResult
-
Returns the value of the
result
record component. - result() - Method in interface io.jenetics.prog.regression.Sample
-
Return the result of the sample point.
- result() - Method in class io.jenetics.stat.DoubleMomentStatistics
- result() - Method in interface io.jenetics.util.Accumulator
-
Return a copy of the current result of the accumulated elements.
- Result(T[], T[]) - Constructor for record class io.jenetics.prog.regression.Sampling.Result
-
Creates an instance of a
Result
record class. - results() - Method in class io.jenetics.ext.rewriting.TreeMatcher
-
Return all matching sub-trees.
- RetryConstraint<G,
C> - Class in io.jenetics.engine -
This simple
Constraint
implementation repairs an invalid phenotype by creating new individuals until a valid one has been created. - RetryConstraint(Predicate<? super Phenotype<G, C>>, Factory<Genotype<G>>, int) - Constructor for class io.jenetics.engine.RetryConstraint
-
Create a new retry-constraint with the given parameters.
- reverse() - Method in interface io.jenetics.util.MSeq
-
Reverses the order of the elements this sequence (in place).
- reversed() - Method in interface io.jenetics.ext.moea.ElementComparator
-
Returns a comparator that imposes the reverse ordering of this comparator.
- reversed() - Method in interface io.jenetics.util.ProxySorter.Comparator
-
Returns a comparator that imposes the reverse ordering of this comparator.
- rewrite(TreeNode<Op<Double>>) - Static method in class io.jenetics.prog.op.MathExpr
-
Applies the
MathExpr.REWRITER
to the given (mutable)tree
. - rewrite(TreeNode<Op<Double>>, int) - Static method in class io.jenetics.prog.op.MathExpr
-
Applies the
MathExpr.REWRITER
to the given (mutable)tree
. - rewrite(TreeNode<Op<T>>, int) - Method in class io.jenetics.prog.op.ConstRewriter
- rewrite(TreeNode<V>) - Method in interface io.jenetics.ext.rewriting.TreeRewriter
-
Applies the rewriting to the given (mutable)
tree
. - rewrite(TreeNode<V>, int) - Method in interface io.jenetics.ext.rewriting.TreeRewriter
-
Applies the rewriting to the given (mutable)
tree
. - rewrite(TreeNode<V>, int) - Method in class io.jenetics.ext.rewriting.TreeRewriteRule
- rewrite(TreeNode<V>, int) - Method in class io.jenetics.ext.rewriting.TRS
- rewrite(TreeNode<V>, int, Iterable<? extends TreeRewriter<V>>) - Static method in interface io.jenetics.ext.rewriting.TreeRewriter
-
Rewrites the given
tree
by applying the givenrewriters
. - rewrite(TreeNode<V>, Iterable<? extends TreeRewriter<V>>) - Static method in interface io.jenetics.ext.rewriting.TreeRewriter
-
Rewrites the given
tree
by applying the givenrewriters
. - REWRITER - Static variable in class io.jenetics.prog.op.MathExpr
-
Combination of the
MathExpr.ARITHMETIC_REWRITER
and theMathExpr.CONST_REWRITER
, in this specific order. - right() - Method in class io.jenetics.ext.rewriting.TreeRewriteRule
-
Return the replacement pattern of the rule.
- RINT - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the double value that is closest in value to the argument and is equal to a mathematical integer.
- rmse(Double[], Double[]) - Static method in interface io.jenetics.prog.regression.LossFunction
-
Root-mean-square error is measured as the average of squared difference between predictions and actual observations.
- root() - Method in class io.jenetics.ext.AbstractTreeGene
- root() - Method in interface io.jenetics.ext.TreeChromosome
-
Return the root gene of this chromosome.
- root() - Method in class io.jenetics.ext.util.FlatTreeNode
-
Returns the root of the tree that contains this node.
- root() - Method in interface io.jenetics.ext.util.Tree
-
Returns the root of the tree that contains this node.
- RouletteWheelSelector<G,
N> - Class in io.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 io.jenetics.RouletteWheelSelector
- RouletteWheelSelector(boolean) - Constructor for class io.jenetics.RouletteWheelSelector
- rows(Reader) - Static method in class io.jenetics.ext.util.CsvSupport
-
Splits the CSV file, given by the
reader
, into aStream
of CSV rows. - RSMutator<G,
C> - Class in io.jenetics.ext -
The reverse sequence mutation, two positions i and j are randomly chosen The gene order in a chromosome will then be reversed between this two points.
- RSMutator() - Constructor for class io.jenetics.ext.RSMutator
-
Default constructor, with default mutation probability (
Alterer.DEFAULT_ALTER_PROBABILITY
). - RSMutator(double) - Constructor for class io.jenetics.ext.RSMutator
-
Constructs an alterer with a given recombination probability.
- rule(Cfg.NonTerminal<?>) - Method in record class io.jenetics.ext.grammar.Cfg
-
Return the rule for the given
start
symbol. - Rule(Cfg.NonTerminal<T>, List<Cfg.Expression<T>>) - Constructor for record class io.jenetics.ext.grammar.Cfg.Rule
-
Creates a new rule object.
- rules() - Method in record class io.jenetics.ext.grammar.Cfg
-
Returns the value of the
rules
record component.
S
- sameState(DoubleMomentStatistics) - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Compares the state of two
DoubleMomentStatistics
objects. - sameState(IntMomentStatistics) - Method in class io.jenetics.stat.IntMomentStatistics
-
Compares the state of two
IntMomentStatistics
objects. - sameState(LongMomentStatistics) - Method in class io.jenetics.stat.LongMomentStatistics
-
Compares the state of two
LongMomentStatistics
objects. - sameState(MinMax<C>) - Method in class io.jenetics.stat.MinMax
-
Compares the state of two
LongMomentStatistics
objects. - sameState(Quantile) - Method in class io.jenetics.stat.Quantile
-
Compares the state of two
Quantile
objects. - sample(RandomGenerator, DoubleRange) - Method in interface io.jenetics.stat.Sampler
-
Create a new
double
sample point within the given range[min, max)
. - sample(RandomGenerator, IntRange) - Method in interface io.jenetics.stat.Sampler
-
Create a new
int
sample point within the given range[min, max)
. - Sample<T> - Interface in io.jenetics.prog.regression
-
Represents a sample point used for the symbolic regression task.
- SampleBuffer<T> - Class in io.jenetics.prog.regression
-
This class holds the actual sample values which are used for the symbolic regression example.
- SampleBuffer(int) - Constructor for class io.jenetics.prog.regression.SampleBuffer
- Sampler - Interface in io.jenetics.stat
-
Interface for creating continuous random samples, with a given distribution.
- Samplers - Class in io.jenetics.stat
-
This class defines some default samplers.
- sampleSize() - Method in class io.jenetics.TournamentSelector
-
Return the sample size of the tournament selector.
- Sampling<T> - Interface in io.jenetics.prog.regression
-
This interface represents a set of sample points, which can be evaluated with a given evolved program.
- Sampling.Result<T> - Record Class in io.jenetics.prog.regression
-
This class represents the result of a sample calculation, which contains the array of calculated values and a corresponding array with expected sample values.
- select(Cfg.NonTerminal<T>, Cfg<T>, SymbolIndex) - Static method in interface io.jenetics.ext.grammar.Generator
-
Standard algorithm for selecting a list of alternative symbols from the given
rule
. - select(Seq<Phenotype<G, C>>, int, Optimize) - Method in class io.jenetics.EliteSelector
- select(Seq<Phenotype<G, C>>, int, Optimize) - Method in class io.jenetics.ext.moea.NSGA2Selector
- select(Seq<Phenotype<G, C>>, int, Optimize) - Method in class io.jenetics.ext.moea.UFTournamentSelector
- select(Seq<Phenotype<G, C>>, int, Optimize) - Method in class io.jenetics.ext.WeaselSelector
- select(Seq<Phenotype<G, C>>, int, Optimize) - Method in class io.jenetics.MonteCarloSelector
- select(Seq<Phenotype<G, C>>, int, Optimize) - Method in class io.jenetics.ProbabilitySelector
- select(Seq<Phenotype<G, C>>, int, Optimize) - Method in interface io.jenetics.Selector
-
Select phenotypes from the Population.
- select(Seq<Phenotype<G, C>>, int, Optimize) - Method in class io.jenetics.TournamentSelector
- select(Seq<Phenotype<G, C>>, int, Optimize) - Method in class io.jenetics.TruncationSelector
-
This method sorts the population in descending order while calculating the selection probabilities.
- select(Seq<Phenotype<G, N>>, int, Optimize) - Method in class io.jenetics.StochasticUniversalSelector
-
This method sorts the population in descending order while calculating the selection probabilities.
- selectionDuration() - Method in class io.jenetics.engine.EvolutionStatistics
-
Return the duration statistics needed for selecting the population, in seconds.
- selector(Selector<G, C>) - Method in class io.jenetics.engine.Engine.Builder
-
The selector used for selecting the survivors and offspring population.
- selector(Selector<G, C>) - Method in class io.jenetics.engine.EvolutionParams.Builder
-
The selector used for selecting the survivors and offspring population.
- Selector<G,
C> - Interface in io.jenetics -
Selectors are responsible for selecting a given number of individuals from the population.
- self() - Method in interface io.jenetics.util.Self
-
Return a reference of
this
object as the declared generic typeS
. - Self<S> - Interface in io.jenetics.util
-
This interface defines a recursive generic type
S
, which represents the type of the implementing class. - SentenceGenerator<T> - Class in io.jenetics.ext.grammar
-
Standard implementation of a sentence generator.
- SentenceGenerator(SymbolIndex, int) - Constructor for class io.jenetics.ext.grammar.SentenceGenerator
-
Create a new sentence generator from the given parameters.
- SentenceGenerator(SymbolIndex, SentenceGenerator.Expansion, int) - Constructor for class io.jenetics.ext.grammar.SentenceGenerator
-
Create a new sentence generator from the given parameters.
- SentenceGenerator.Expansion - Enum Class in io.jenetics.ext.grammar
-
Defines the expansion strategy used when generating the sentences.
- Separator(char) - Constructor for record class io.jenetics.ext.util.CsvSupport.Separator
-
Creates a new Separator char object.
- Seq<T> - Interface in io.jenetics.util
-
General interface for a ordered, fixed sized, object sequence.
- set(int, T) - Method in interface io.jenetics.util.MSeq
-
Set the
value
at the givenindex
. - setAll(Iterable<? extends T>) - Method in interface io.jenetics.util.MSeq
-
Fills the sequence with values of the given iterable.
- setAll(Iterator<? extends T>) - Method in interface io.jenetics.util.MSeq
-
Fills the sequence with values of the given iterator.
- setAll(T[]) - Method in interface io.jenetics.util.MSeq
-
Fill the sequence with the given values.
- setup(Engine.Setup<G, C>) - Method in class io.jenetics.engine.Engine.Builder
-
Applies the given
setup
recipe tothis
engine builder. - Setup of a local PRNG - Search tag in class io.jenetics.util.RandomRegistry
- Section
- Setup the PRNG used for the evolution process - Search tag in class io.jenetics.util.RandomRegistry
- Section
- sharedAncestor(T) - Method in interface io.jenetics.ext.util.Tree
-
Returns the nearest common ancestor to this node and the given
node
. - shiftLeft(int) - Method in class io.jenetics.BitChromosome
-
Returns a new
BitChromosome
whose value is (this << n
). - ShiftMutator<G,
C> - Class in io.jenetics -
The shift mutation applies mutation between two randomly chosen points.
- ShiftMutator() - Constructor for class io.jenetics.ShiftMutator
-
Default constructor, with default mutation probability (
Alterer.DEFAULT_ALTER_PROBABILITY
). - ShiftMutator(double) - Constructor for class io.jenetics.ShiftMutator
-
Constructs an alterer with a given recombination probability.
- ShiftMutator(ShiftMutator.RangeRandom) - Constructor for class io.jenetics.ShiftMutator
-
Constructs an alterer with a given shifter-random.
- ShiftMutator(ShiftMutator.RangeRandom, double) - Constructor for class io.jenetics.ShiftMutator
-
Constructs an alterer with a given shifter-random and recombination probability.
- ShiftMutator.Range - Record Class in io.jenetics
-
This class defines the
Chromosome
shift indexes. - ShiftMutator.RangeRandom - Interface in io.jenetics
-
Functional interface for creating random shift ranges objects for shifting sequences of a given length.
- shiftRight(int) - Method in class io.jenetics.BitChromosome
-
Returns a new
BitChromosome
whose value is (this >> n
). - shortValue() - Method in class io.jenetics.DoubleGene
- shortValue() - Method in class io.jenetics.IntegerGene
- shortValue() - Method in class io.jenetics.LongGene
- shortValue() - Method in interface io.jenetics.NumericChromosome
-
Return the short value of this
NumericChromosome
at theindex
0. - shortValue() - Method in interface io.jenetics.NumericGene
-
Returns the value of the specified gene as a short.
- shortValue(int) - Method in interface io.jenetics.NumericChromosome
-
Return the short value of this
NumericChromosome
at the givenindex
. - shuffle() - Method in interface io.jenetics.util.MSeq
-
Randomize the
array
using theRandomGenerator
object currently registered in theRandomRegistry
class. - shuffle(RandomGenerator) - Method in interface io.jenetics.util.MSeq
-
Randomize the
array
using the givenRandomGenerator
object. - ShuffleMutator<G,
C> - Class in io.jenetics -
The shuffle mutation, changes the order of the genes between two randomly chosen positions.
- ShuffleMutator() - Constructor for class io.jenetics.ShuffleMutator
-
Default constructor, with default mutation probability (
Alterer.DEFAULT_ALTER_PROBABILITY
). - ShuffleMutator(double) - Constructor for class io.jenetics.ShuffleMutator
-
Constructs an alterer with a given recombination probability.
- ShuffleMutator(ShuffleMutator.RangeRandom, double) - Constructor for class io.jenetics.ShuffleMutator
-
Constructs an alterer with a given recombination probability and random range generator.
- ShuffleMutator.Range - Record Class in io.jenetics
-
Represents the chromosome range which will be shuffled
- ShuffleMutator.RangeRandom - Interface in io.jenetics
-
Functional interface for creating random range objects for shuffling sequences of a given length.
- siblingCount() - Method in interface io.jenetics.ext.util.Tree
-
Return the number of siblings of
this
node. - SIGNUM - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the signum function of the argument; zero if the argument is zero, 1.0 if the argument is greater than zero, -1.0 if the argument is less than zero.
- simplify() - Method in class io.jenetics.prog.op.MathExpr
-
Simplifies
this
expression by applying the defaultMathExpr.REWRITER
. - simplify(TreeRewriter<Op<Double>>) - Method in class io.jenetics.prog.op.MathExpr
-
Simplifying
this
expression by applying the givenrewriter
. - simplify(TreeRewriter<Op<Double>>, int) - Method in class io.jenetics.prog.op.MathExpr
-
Simplifying
this
expression by applying the givenrewriter
and the given rewritelimit
. - SimulatedBinaryCrossover<G,
C> - Class in io.jenetics.ext -
Performs the simulated binary crossover (SBX) on a
Chromosome
ofNumericGene
s such that each position is either crossed contracted or expanded with a certain probability. - SimulatedBinaryCrossover(double) - Constructor for class io.jenetics.ext.SimulatedBinaryCrossover
-
Create a new simulated binary crossover alterer with the given parameters.
- SimulatedBinaryCrossover(double, double) - Constructor for class io.jenetics.ext.SimulatedBinaryCrossover
-
Create a new simulated binary crossover alterer with the given parameters.
- SIN - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the trigonometric sine of an angle.
- singleBitChromosomeMapper(Cfg<? extends T>, int, Function<? super SymbolIndex, ? extends Generator<T, R>>) - Static method in class io.jenetics.ext.grammar.Mappers
-
Return a classic mapping codec.
- singleIntegerChromosomeMapper(Cfg<? extends T>, IntRange, int, Function<? super SymbolIndex, ? extends Generator<T, R>>) - Static method in class io.jenetics.ext.grammar.Mappers
-
Create a mapping codec, similar as in
Mappers.singleBitChromosomeMapper(Cfg, int, Function)
. - singleIntegerChromosomeMapper(Cfg<? extends T>, IntRange, IntRange, Function<? super SymbolIndex, ? extends Generator<T, R>>) - Static method in class io.jenetics.ext.grammar.Mappers
-
Create a mapping codec, similar as in
Mappers.singleBitChromosomeMapper(Cfg, int, Function)
. - SingleNodeCrossover<G,
C> - Class in io.jenetics.ext -
Swaps two, randomly chosen, nodes (subtrees) from two given trees.
- SingleNodeCrossover() - Constructor for class io.jenetics.ext.SingleNodeCrossover
- SingleNodeCrossover(double) - Constructor for class io.jenetics.ext.SingleNodeCrossover
- SinglePointCrossover<G,
C> - Class in io.jenetics -
Single point crossover
- SinglePointCrossover() - Constructor for class io.jenetics.SinglePointCrossover
-
Create a new single-point crossover object with crossover probability of
0.05
. - SinglePointCrossover(double) - Constructor for class io.jenetics.SinglePointCrossover
-
Constructs an alterer with a given recombination probability.
- SINH - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the hyperbolic sine of a double value.
- size() - Method in class io.jenetics.ext.AbstractTreeGene
- size() - Method in class io.jenetics.ext.moea.ParetoFront
- size() - Method in class io.jenetics.ext.util.FlatTreeNode
- size() - Method in interface io.jenetics.ext.util.Tree
-
Return the number of nodes of
this
node (subtree). - size() - Method in class io.jenetics.util.IntRange
-
Return the size of the
IntRange
:max - min
. - size() - Method in interface io.jenetics.util.Seq
- skewness() - Method in record class io.jenetics.stat.DoubleMoments
-
Returns the value of the
skewness
record component. - skewness() - Method in record class io.jenetics.stat.IntMoments
-
Returns the value of the
skewness
record component. - skewness() - Method in record class io.jenetics.stat.LongMoments
-
Returns the value of the
skewness
record component. - skewness() - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Return the skewness of values recorded, or
Double.NaN
if less than two values have been recorded. - skewness() - Method in class io.jenetics.stat.IntMomentStatistics
-
Return the skewness of values recorded, or
Double.NaN
if less than two values have been recorded. - skewness() - Method in class io.jenetics.stat.LongMomentStatistics
-
Return the skewness of values recorded, or
Double.NaN
if less than two values have been recorded. - slice(int, int) - Method in class io.jenetics.Genotype
-
Create a new Genotype which consists of the chromosomes from the given
fromIndex
(inclusively) to the giventoIndex
(exclusively). - sort() - Method in interface io.jenetics.util.MSeq
-
Sorts this sequence according to the natural order of the elements.
- sort(double[]) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(double[], int, int) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(int) - Method in interface io.jenetics.util.MSeq
-
Sorts this sequence according to the natural order of the elements.
- sort(int[]) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(int[], int, int) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(int, int) - Method in interface io.jenetics.util.MSeq
-
Sorts this sequence according to the natural order of the elements.
- sort(int, int, Comparator<? super T>) - Method in interface io.jenetics.util.MSeq
-
Sorts this sequence according to the order induced by the specified
Comparator
. - sort(int, Comparator<? super T>) - Method in interface io.jenetics.util.MSeq
-
Sorts this sequence according to the order induced by the specified
Comparator
. - sort(long[]) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(long[], int, int) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(BaseSeq<? extends T>) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(BaseSeq<? extends T>, int, int) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(BaseSeq<? extends T>, int, int, Comparator<? super T>) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(BaseSeq<? extends T>, Comparator<? super T>) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(Comparator<? super T>) - Method in interface io.jenetics.util.MSeq
-
Sorts this sequence according to the order induced by the specified
Comparator
. - sort(List<? extends T>) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(List<? extends T>, int, int) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(List<? extends T>, int, int, Comparator<? super T>) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(List<? extends T>, Comparator<? super T>) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(T[]) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(T[], int, int) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(T[], int, int, Comparator<? super T>) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(T[], Comparator<? super T>) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(T, int, int, ProxySorter.Comparator<? super T>) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- sort(T, int, ProxySorter.Comparator<? super T>) - Static method in class io.jenetics.util.ProxySorter
-
Sorting the given array by creating an index lookup array.
- split(CharSequence) - Method in class io.jenetics.ext.util.CsvSupport.LineSplitter
-
Splitting the given CSV
line
into its columns. - split(CharSequence) - Static method in class io.jenetics.ext.util.CsvSupport
-
Splits a given CSV
line
into columns. - spliterator() - Method in interface io.jenetics.util.BaseSeq
- SQR - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the square value of a given double value.
- SQRT - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the correctly rounded positive square root of a double value.
- start() - Method in record class io.jenetics.ext.grammar.Cfg.Rule
-
Returns the value of the
start
record component. - start() - Method in record class io.jenetics.ext.grammar.Cfg
-
Returns the value of the
start
record component. - StochasticUniversalSelector<G,
N> - Class in io.jenetics -
StochasticUniversalSelector
is a method for selecting a population according to some given probability in a way that minimizes chance fluctuations. - StochasticUniversalSelector() - Constructor for class io.jenetics.StochasticUniversalSelector
- stream() - Method in interface io.jenetics.engine.EvolutionStreamable
-
Create a new, possibly infinite, evolution stream with a newly created population.
- stream() - Method in interface io.jenetics.ext.util.Tree
-
Return a stream that traverses the subtree rooted at
this
node in breadth-first order. - stream() - Method in interface io.jenetics.util.BaseSeq
-
Returns a sequential Stream with this sequence as its source.
- stream() - Method in class io.jenetics.util.IntRange
-
Returns a sequential ordered
IntStream
fromIntRange.min()
(inclusive) toIntRange.max()
(exclusive) by an incremental step of1
. - stream() - Method in class io.jenetics.util.LongRange
-
Returns a sequential ordered
LongStream
fromLongRange.min()
(inclusive) toLongRange.max()
(exclusive) by an incremental step of1
. - stream(EvolutionInit<G>) - Method in class io.jenetics.engine.Engine
- stream(EvolutionInit<G>) - Method in interface io.jenetics.engine.EvolutionStreamable
-
Create a new, possibly infinite, evolution stream with the given initial value.
- stream(EvolutionInit<G>) - Method in class io.jenetics.ext.engine.ConcatEngine
- stream(EvolutionInit<G>) - Method in class io.jenetics.ext.engine.CyclicEngine
- stream(EvolutionResult<G, C>) - Method in interface io.jenetics.engine.EvolutionStreamable
-
Create a new
EvolutionStream
starting with a previously evolvedEvolutionResult
. - stream(EvolutionStart<G, C>) - Method in interface io.jenetics.engine.EvolutionStreamable
-
Create a new, possibly infinite, evolution stream with the given evolution start.
- stream(ISeq<Phenotype<G, C>>) - Method in interface io.jenetics.engine.EvolutionStreamable
-
Create a new, possibly infinite, evolution stream with the given initial population.
- stream(ISeq<Phenotype<G, C>>, long) - Method in interface io.jenetics.engine.EvolutionStreamable
-
Create a new, possibly infinite, evolution stream with the given initial population.
- stream(Iterable<Genotype<G>>) - Method in interface io.jenetics.engine.EvolutionStreamable
-
Create a new, possibly infinite, evolution stream with the given initial individuals.
- stream(Iterable<Genotype<G>>, long) - Method in interface io.jenetics.engine.EvolutionStreamable
-
Create a new, possibly infinite, evolution stream with the given initial individuals.
- stream(Supplier<EvolutionStart<G, C>>) - Method in class io.jenetics.engine.Engine
- stream(Supplier<EvolutionStart<G, C>>) - Method in interface io.jenetics.engine.EvolutionStreamable
-
Create a new, possibly infinite, evolution stream with the given evolution start.
- stream(Supplier<EvolutionStart<G, C>>) - Method in class io.jenetics.ext.engine.ConcatEngine
- stream(Supplier<EvolutionStart<G, C>>) - Method in class io.jenetics.ext.engine.CyclicEngine
- StreamPublisher<T> - Class in io.jenetics.util
-
This class allows creating a reactive
Flow.Publisher
from a given JavaStream
. - StreamPublisher() - Constructor for class io.jenetics.util.StreamPublisher
-
Creates a new publisher using the
ForkJoinPool.commonPool()
for async delivery to subscribers (unless it does not support a parallelism level of at least two, in which case, a new Thread is created to run each task), with maximum buffer capacity ofFlow.defaultBufferSize()
, and no handler for Subscriber exceptions in method onNext. - StreamPublisher(Executor, int) - Constructor for class io.jenetics.util.StreamPublisher
-
Creates a new
StreamPublisher
using the givenExecutor
for async delivery to subscribers, with the given maximum buffer size for each subscriber, and no handler for Subscriber exceptions in methodFlow.Subscriber.onNext(Object)
. - StreamPublisher(Executor, int, BiConsumer<? super Flow.Subscriber<? super T>, ? super Throwable>) - Constructor for class io.jenetics.util.StreamPublisher
-
Creates a new
StreamPublisher
using the givenExecutor
for async delivery to subscribers, with the given maximum buffer size for each subscriber. - Streams - Class in io.jenetics.util
-
This class contains factory methods for (flat) mapping stream elements.
- SUB - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Return the diff of its arguments.
- subSeq(int) - Method in interface io.jenetics.util.ISeq
- subSeq(int) - Method in interface io.jenetics.util.MSeq
- subSeq(int) - Method in interface io.jenetics.util.Seq
-
Returns a view of the portion of this sequence between the specified
start
, inclusive, andend
, exclusive. - subSeq(int, int) - Method in interface io.jenetics.util.ISeq
- subSeq(int, int) - Method in interface io.jenetics.util.MSeq
- subSeq(int, int) - Method in interface io.jenetics.util.Seq
-
Returns a view of the portion of this sequence between the specified
start
, inclusive, andend
, exclusive. - subSequence(int, int) - Method in class io.jenetics.CharacterChromosome
- subSequence(int, int) - Method in class io.jenetics.util.CharSeq
- sum() - Method in record class io.jenetics.stat.DoubleMoments
-
Returns the value of the
sum
record component. - sum() - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Return the sum of values recorded, or zero if no values have been recorded.
- sum() - Method in record class io.jenetics.stat.DoubleSummary
-
Returns the value of the
sum
record component. - sum() - Method in record class io.jenetics.stat.IntMoments
-
Returns the value of the
sum
record component. - sum() - Method in class io.jenetics.stat.IntMomentStatistics
-
Return the sum of values recorded, or zero if no values have been recorded.
- sum() - Method in record class io.jenetics.stat.IntSummary
-
Returns the value of the
sum
record component. - sum() - Method in record class io.jenetics.stat.LongMoments
-
Returns the value of the
sum
record component. - sum() - Method in class io.jenetics.stat.LongMomentStatistics
-
Return the sum of values recorded, or zero if no values have been recorded.
- sum() - Method in record class io.jenetics.stat.LongSummary
-
Returns the value of the
sum
record component. - sum(double[]) - Static method in record class io.jenetics.stat.DoubleSummary
-
Return the sum of the given double array.
- sum(int[]) - Static method in record class io.jenetics.stat.IntSummary
-
Return the sum of the given double array.
- sum(long[]) - Static method in record class io.jenetics.stat.LongSummary
-
Return the sum of the given double array.
- survivorFilterDuration() - Method in record class io.jenetics.engine.EvolutionDurations
-
Returns the value of the
survivorFilterDuration
record component. - survivorsFraction(double) - Method in class io.jenetics.engine.Engine.Builder
-
The survivor fraction.
- survivorsSelectionDuration() - Method in record class io.jenetics.engine.EvolutionDurations
-
Returns the value of the
survivorsSelectionDuration
record component. - survivorsSelector() - Method in class io.jenetics.engine.Engine.Builder
-
Return the used survivor
Selector
of the GA. - survivorsSelector() - Method in class io.jenetics.engine.Engine
-
Return the used survivor
Selector
of the GA. - survivorsSelector() - Method in class io.jenetics.engine.EvolutionParams.Builder
-
Return the used survivor
Selector
of the GA. - survivorsSelector() - Method in class io.jenetics.engine.EvolutionParams
-
Return the used survivor
Selector
of the GA. - survivorsSelector(Selector<G, C>) - Method in class io.jenetics.engine.Engine.Builder
-
The selector used for selecting the survivor population.
- survivorsSelector(Selector<G, C>) - Method in class io.jenetics.engine.EvolutionParams.Builder
-
The selector used for selecting the survivor population.
- survivorsSize() - Method in class io.jenetics.engine.Engine
-
The number of selected survivors.
- survivorsSize() - Method in class io.jenetics.engine.EvolutionParams.Builder
-
Return the number of survivors.
- survivorsSize() - Method in class io.jenetics.engine.EvolutionParams
-
Return the number of survivors.
- survivorsSize(int) - Method in class io.jenetics.engine.Engine.Builder
-
The number of survivors.
- swap(int, int) - Method in interface io.jenetics.util.MSeq
-
Swap the elements at the two positions.
- swap(int, int, MSeq<T>, int) - Method in interface io.jenetics.util.MSeq
-
Swap a given range with a range of the same size with another array.
- swap(int, MSeq<T>) - Method in interface io.jenetics.util.MSeq
-
Swap the elements at the same position.
- SwapMutator<G,
C> - Class in io.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() - Constructor for class io.jenetics.SwapMutator
-
Default constructor, with default mutation probability (
Alterer.DEFAULT_ALTER_PROBABILITY
). - SwapMutator(double) - Constructor for class io.jenetics.SwapMutator
-
Constructs an alterer with a given recombination probability.
- swapProbability() - Method in class io.jenetics.UniformCrossover
-
Return the probability for swapping genes of a chromosome.
- SymbolIndex - Interface in io.jenetics.ext.grammar
-
Functional interface for selecting a
Cfg.Symbol
by its index within a rule. - symbols() - Method in record class io.jenetics.ext.grammar.Cfg.Expression
-
Returns the value of the
symbols
record component. - synced() - Method in interface io.jenetics.util.Accumulator
-
Returns a synchronized (thread-safe) accumulator backed by
this
accumulator. - synced(Object) - Method in interface io.jenetics.util.Accumulator
-
Returns a synchronized (thread-safe) accumulator backed by
this
accumulator. - system(ZoneId) - Static method in class io.jenetics.util.NanoClock
-
This clock is based on the nano system clock.
- systemDefaultZone() - Static method in class io.jenetics.util.NanoClock
-
This clock is based on the nano system clock.
- systemUTC() - Static method in class io.jenetics.util.NanoClock
-
This clock is based on the nano system clock.
T
- T(String) - Static method in record class io.jenetics.ext.grammar.Cfg
-
Factory method for creating a terminal symbol with the given
name
. - T(String, T) - Static method in record class io.jenetics.ext.grammar.Cfg
-
Factory method for creating a terminal symbol with the given
name
andvalue
. - TAN - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the trigonometric tangent of an angle.
- TANH - Enum constant in enum class io.jenetics.prog.op.MathOp
-
Returns the hyperbolic tangent of a double value.
- Terminal(String, T) - Constructor for record class io.jenetics.ext.grammar.Cfg.Terminal
-
Creates an instance of a
Terminal
record class. - terminals() - Method in record class io.jenetics.ext.grammar.Cfg
-
Returns the value of the
terminals
record component. - terminals() - Method in class io.jenetics.prog.ProgramChromosome
-
Return the allowed terminal operations.
- terminals() - Method in class io.jenetics.prog.ProgramGene
-
Return the allowed terminal operations.
- test(Phenotype<G, C>) - Method in interface io.jenetics.engine.Constraint
-
Checks the validity of the given
individual
. - test(Phenotype<G, C>) - Method in class io.jenetics.engine.RetryConstraint
- text() - Static method in class io.jenetics.xml.stream.Reader
-
Return a
Reader
for reading the text of an element. - text() - Static method in interface io.jenetics.xml.stream.Writer
-
Create a new text
Writer
, which writes the given data as string to the outer element. - toArray() - Method in class io.jenetics.CharacterChromosome
-
Returns a char array containing all the elements in this chromosome in a proper sequence.
- toArray() - Method in class io.jenetics.DoubleChromosome
-
Returns a double array containing all the elements in this chromosome in a proper sequence.
- toArray() - Method in class io.jenetics.ext.util.Tree.Path
-
Return the path as
int[]
array. - toArray() - Method in class io.jenetics.IntegerChromosome
-
Returns an int array containing all the elements in this chromosome in a proper sequence.
- toArray() - Method in class io.jenetics.LongChromosome
-
Returns a long array containing all the elements in this chromosome in a proper sequence.
- toArray() - Method in interface io.jenetics.util.Seq
-
Return an array containing all of the elements in this sequence in right order.
- toArray(char[]) - Method in class io.jenetics.CharacterChromosome
-
Returns a char array containing all the elements in this chromosome in a proper sequence.
- toArray(double[]) - Method in class io.jenetics.DoubleChromosome
-
Returns a double array containing all the elements in this chromosome in a proper sequence.
- toArray(int[]) - Method in class io.jenetics.IntegerChromosome
-
Returns an int array containing all the elements in this chromosome in a proper sequence.
- toArray(long[]) - Method in class io.jenetics.LongChromosome
-
Returns a long array containing all the elements in this chromosome in a proper sequence.
- toArray(B[]) - Method in interface io.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.
- toArray(IntFunction<B[]>) - Method in interface io.jenetics.util.Seq
-
Returns an array containing the elements of this sequence, using the provided generator function to allocate the returned array.
- toBestEvolutionResult() - Static method in class io.jenetics.engine.EvolutionResult
-
Return a collector which collects the best result of an evolution stream.
- toBestGenotype() - Static method in class io.jenetics.engine.EvolutionResult
-
Return a collector which collects the best genotype of an evolution stream.
- toBestPhenotype() - Static method in class io.jenetics.engine.EvolutionResult
-
Return a collector which collects the best phenotype of an evolution stream.
- toBestResult(Codec<T, G>) - Static method in class io.jenetics.engine.EvolutionResult
-
Return a collector which collects the best result (in the native problem space).
- toBestResult(Function<Genotype<G>, T>) - Static method in class io.jenetics.engine.EvolutionResult
-
Return a collector which collects the best result (in the native problem space).
- toBigInteger() - Method in class io.jenetics.BitChromosome
-
Return the
BigInteger
value thisBitChromosome
represents. - toBitSet() - Method in class io.jenetics.BitChromosome
-
Return the corresponding BitSet of this BitChromosome.
- toBoolOp(String) - Static method in enum class io.jenetics.prog.op.BoolOp
-
Converts the string representation of an operation to the operation object.
- toBuilder() - Method in class io.jenetics.engine.Engine
-
Create a new evolution
Engine.Builder
initialized with the values of the current evolutionEngine
. - toBuilder() - Method in class io.jenetics.engine.EvolutionParams
-
Return a new builder object, initialized with
this
parameters. - toByteArray() - Method in class io.jenetics.BitChromosome
-
Returns the byte array, which represents the bit values of
this
chromosome. - toByteArray(Object) - Method in class io.jenetics.util.IO
-
Serializes the given
object
to abyte[]
array. - toCanonicalString() - Method in class io.jenetics.BitChromosome
-
Return the BitChromosome as String.
- toCharSeq() - Static method in class io.jenetics.util.CharSeq
- toComponents(Record) - Static method in class io.jenetics.ext.util.CsvSupport
-
Converts the given
record
into its components. - toCsv() - Static method in class io.jenetics.ext.util.CsvSupport
-
Return a collector for joining a list of CSV rows into one CSV string.
- toCsv(String) - Static method in class io.jenetics.ext.util.CsvSupport
-
Return a collector for joining a list of CSV rows into one CSV string.
- toDoubleMoments() - Static method in record class io.jenetics.stat.DoubleMoments
-
Return a
Collector
which returns moments-statistics for the resulting values. - toDoubleMoments() - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Return a
DoubleMoments
object from the current statistics, - toDoubleMoments(ToDoubleFunction<? super T>) - Static method in record class io.jenetics.stat.DoubleMoments
-
Return a
Collector
which applies a double-producing mapping function to each input element, and returns moments-statistics for the resulting values. - toDoubleMomentStatistics(ToDoubleFunction<? super T>) - Static method in class io.jenetics.stat.DoubleMomentStatistics
-
Return a
Collector
which applies a double-producing mapping function to each input element, and returns moments-statistics for the resulting values. - toDoubleSummary(ToDoubleFunction<? super T>) - Static method in record class io.jenetics.stat.DoubleSummary
-
Return a
Collector
which applies a double-producing mapping function to each input element, and return summary-statistics for the resulting values. - toEvolutionStart() - Method in class io.jenetics.engine.EvolutionResult
-
Return the current evolution result object as an
EvolutionStart
object with the current population and current total generation. - toIntervalBest(Comparator<? super C>, int) - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function which returns (emits) the minimal value of the last n elements.
- toIntervalBest(Comparator<? super C>, Duration) - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function which returns (emits) the minimal value of the elements emitted within the given
timespan
. - toIntervalBest(Comparator<? super C>, Duration, Clock) - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function which returns (emits) the minimal value of the elements emitted within the given
timespan
. - toIntervalMax(int) - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function which returns (emits) the maximal value of the last n elements.
- toIntervalMax(Duration) - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function which returns (emits) the maximal value of the elements emitted within the given
timespan
. - toIntervalMax(Duration, Clock) - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function which returns (emits) the maximal value of the elements emitted within the given
timespan
. - toIntervalMin(int) - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function which returns (emits) the minimal value of the last n elements.
- toIntervalMin(Duration) - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function which returns (emits) the minimal value of the elements emitted within the given
timespan
. - toIntervalMin(Duration, Clock) - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function which returns (emits) the minimal value of the elements emitted within the given
timespan
. - toIntMoments() - Static method in record class io.jenetics.stat.IntMoments
-
Return a
Collector
which returns moments-statistics for the resulting values. - toIntMoments() - Method in class io.jenetics.stat.IntMomentStatistics
-
Return an
IntMoments
object from the current statistics, - toIntMoments(ToIntFunction<? super T>) - Static method in record class io.jenetics.stat.IntMoments
-
Return a
Collector
which applies an int-producing mapping function to each input element, and returns moments-statistics for the resulting values. - toIntMomentStatistics(ToIntFunction<? super T>) - Static method in class io.jenetics.stat.IntMomentStatistics
-
Return a
Collector
which applies an int-producing mapping function to each input element, and returns moments-statistics for the resulting values. - toIntSummary(ToIntFunction<? super T>) - Static method in record class io.jenetics.stat.IntSummary
-
Return a
Collector
which applies an int-producing mapping function to each input element, and return summary-statistics for the resulting values. - toInvertibleCodec(Function<? super T, Genotype<G>>) - Method in interface io.jenetics.engine.Codec
-
Converts this codec into an invertible codec, by using the given
encoder
(inversion) function. - toISeq() - Method in class io.jenetics.ext.moea.ParetoFront
-
Return the elements of
this
pareto-front asISeq
. - toISeq() - Static method in interface io.jenetics.util.ISeq
-
Returns a
Collector
that accumulates the input elements into a newISeq
. - toISeq() - Method in interface io.jenetics.util.MSeq
-
Return a read-only projection of this sequence.
- toISeq(int) - Static method in interface io.jenetics.util.ISeq
-
Returns a
Collector
that accumulates the lastn
input elements into a newISeq
. - toISeq(CharSequence) - Static method in class io.jenetics.util.CharSeq
-
Helper method for creating a sequence of characters from the given
CharSequence
. - toLongMoments() - Static method in record class io.jenetics.stat.LongMoments
-
Return a
Collector
which returns moments-statistics for the resulting values. - toLongMoments() - Method in class io.jenetics.stat.LongMomentStatistics
-
Return a
LongMoments
object from the current statistics, - toLongMoments(ToLongFunction<? super T>) - Static method in record class io.jenetics.stat.LongMoments
-
Return a
Collector
which applies a long-producing mapping function to each input element, and returns moments-statistics for the resulting values. - toLongMomentStatistics(ToLongFunction<? super T>) - Static method in class io.jenetics.stat.LongMomentStatistics
-
Return a
Collector
which applies a long-producing mapping function to each input element, and returns moments-statistics for the resulting values. - toLongSummary(ToLongFunction<? super T>) - Static method in record class io.jenetics.stat.LongSummary
-
Return a
Collector
which applies a long-producing mapping function to each input element, and return summary-statistics for the resulting values. - toMathOp(String) - Static method in enum class io.jenetics.prog.op.MathOp
-
Converts the string representation of an operation to the operation object.
- toMedian(ToDoubleFunction<? super T>) - Static method in class io.jenetics.stat.Quantile
-
Return a
Collector
which applies a double-producing mapping function to each input element, and returns the median for the resulting values. - toMinMax() - Static method in class io.jenetics.stat.MinMax
-
Return a
Collector
which calculates the minimum and maximum value. - toMinMax(Comparator<? super T>) - Static method in class io.jenetics.stat.MinMax
-
Return a
Collector
which calculates the minimum and maximum value. - toMSeq() - Static method in interface io.jenetics.util.MSeq
-
Returns a
Collector
that accumulates the input elements into a newMSeq
. - toParenthesesString() - Method in interface io.jenetics.ext.util.Tree
-
Return a compact string representation of the given tree.
- toParenthesesString(Function<? super V, String>) - Method in interface io.jenetics.ext.util.Tree
-
Return a compact string representation of the given tree.
- toParetoFront() - Static method in class io.jenetics.ext.moea.ParetoFront
-
Return a pareto-front collector.
- toParetoFront(Comparator<? super T>) - Static method in class io.jenetics.ext.moea.ParetoFront
-
Return a pareto-front collector with the given pareto
dominance
measure. - toParetoSet() - Static method in class io.jenetics.ext.moea.MOEA
-
Collector of
Phenotype
objects, who's (multi-objective) fitness value is part of the pareto front. - toParetoSet(IntRange) - Static method in class io.jenetics.ext.moea.MOEA
-
Collector of
Phenotype
objects, who's (multi-objective) fitness value is part of the pareto front. - toParetoSet(IntRange, Comparator<? super C>, ElementComparator<? super C>, ElementDistance<? super C>, ToIntFunction<? super C>) - Static method in class io.jenetics.ext.moea.MOEA
-
Collector of
Phenotype
objects, who's (multi-objective) fitness value is part of the pareto front. - toQuantile(double, ToDoubleFunction<? super T>) - Static method in class io.jenetics.stat.Quantile
-
Return a
Collector
which applies a double-producing mapping function to each input element, and returns quantiles for the resulting values. - toSeq() - Static method in interface io.jenetics.util.Seq
-
Returns a
Collector
that accumulates the input elements into a newSeq
. - toSeq(int) - Static method in interface io.jenetics.util.Seq
-
Returns a
Collector
that accumulates the lastn
input elements into a newSeq
. - toStrictlyDecreasing() - Static method in class io.jenetics.stat.MinMax
-
Return a new flat-mapper function, which guarantees a strictly decreasing stream, from an arbitrarily ordered source stream.
- toStrictlyDecreasing() - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function, which guarantees a strictly decreasing stream, from an arbitrarily ordered source stream.
- toStrictlyImproving(Comparator<? super T>) - Static method in class io.jenetics.stat.MinMax
-
Return a new flat-mapper function, which guarantees a strictly improving stream, from an arbitrarily ordered source stream.
- toStrictlyImproving(Comparator<? super T>) - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function, which guarantees a strictly improving stream, from an arbitrarily ordered source stream.
- toStrictlyIncreasing() - Static method in class io.jenetics.stat.MinMax
-
Return a new flat-mapper function, which guarantees a strictly increasing stream, from an arbitrarily ordered source stream.
- toStrictlyIncreasing() - Static method in class io.jenetics.util.Streams
-
Return a new flat-mapper function, which guarantees a strictly increasing stream, from an arbitrarily ordered source stream.
- toString() - Method in class io.jenetics.AbstractChromosome
- toString() - Method in record class io.jenetics.AltererResult
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.AnyGene
- toString() - Method in class io.jenetics.BitChromosome
- toString() - Method in enum class io.jenetics.BitGene
- toString() - Method in class io.jenetics.BoltzmannSelector
- toString() - Method in class io.jenetics.CharacterChromosome
- toString() - Method in class io.jenetics.CharacterGene
- toString() - Method in class io.jenetics.CombineAlterer
- toString() - Method in class io.jenetics.DoubleGene
- toString() - Method in class io.jenetics.EliteSelector
- toString() - Method in record class io.jenetics.engine.EvolutionDurations
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.engine.EvolutionInit
- toString() - Method in class io.jenetics.engine.EvolutionStart
- toString() - Method in class io.jenetics.engine.EvolutionStatistics
- toString() - Method in class io.jenetics.EnumGene
- toString() - Method in class io.jenetics.ExponentialRankSelector
- toString() - Method in class io.jenetics.ext.AbstractTreeGene
- toString() - Method in class io.jenetics.ext.BigIntegerGene
- toString() - Method in record class io.jenetics.ext.grammar.Cfg.Expression
-
Returns a string representation of this record class.
- toString() - Method in record class io.jenetics.ext.grammar.Cfg.NonTerminal
-
Returns a string representation of this record class.
- toString() - Method in record class io.jenetics.ext.grammar.Cfg.Rule
-
Returns a string representation of this record class.
- toString() - Method in record class io.jenetics.ext.grammar.Cfg.Terminal
-
Returns a string representation of this record class.
- toString() - Method in record class io.jenetics.ext.grammar.Cfg
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.ext.rewriting.TreeMatchResult
- toString() - Method in class io.jenetics.ext.rewriting.TreePattern
- toString() - Method in record class io.jenetics.ext.rewriting.TreePattern.Val
-
Returns a string representation of this record class.
- toString() - Method in record class io.jenetics.ext.rewriting.TreePattern.Var
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.ext.rewriting.TreeRewriteRule
- toString() - Method in class io.jenetics.ext.rewriting.TRS
- toString() - Method in class io.jenetics.ext.SimulatedBinaryCrossover
- toString() - Method in class io.jenetics.ext.SingleNodeCrossover
- toString() - Method in record class io.jenetics.ext.util.CsvSupport.ColumnIndexes
-
Returns a string representation of this record class.
- toString() - Method in record class io.jenetics.ext.util.CsvSupport.Quote
-
Returns a string representation of this record class.
- toString() - Method in record class io.jenetics.ext.util.CsvSupport.Separator
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.ext.util.FlatTreeNode
- toString() - Method in class io.jenetics.ext.util.Tree.Path
- toString() - Method in class io.jenetics.ext.util.TreeNode
- toString() - Method in class io.jenetics.ext.WeaselMutator
- toString() - Method in class io.jenetics.ext.WeaselSelector
- toString() - Method in class io.jenetics.Genotype
- toString() - Method in class io.jenetics.IntegerGene
- toString() - Method in class io.jenetics.IntermediateCrossover
- toString() - Method in class io.jenetics.LinearRankSelector
- toString() - Method in class io.jenetics.LineCrossover
- toString() - Method in class io.jenetics.LongGene
- toString() - Method in class io.jenetics.MonteCarloSelector
- toString() - Method in class io.jenetics.MultiPointCrossover
- toString() - Method in class io.jenetics.Mutator
- toString() - Method in record class io.jenetics.MutatorResult
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.PartiallyMatchedCrossover
- toString() - Method in class io.jenetics.PermutationChromosome
- toString() - Method in class io.jenetics.Phenotype
- toString() - Method in enum class io.jenetics.prog.op.BoolOp
- toString() - Method in class io.jenetics.prog.op.Const
- toString() - Method in class io.jenetics.prog.op.ConstRewriter
- toString() - Method in class io.jenetics.prog.op.EphemeralConst
- toString() - Method in class io.jenetics.prog.op.MathExpr
-
Return the string representation of this
MathExpr
object. - toString() - Method in enum class io.jenetics.prog.op.MathOp
- toString() - Method in class io.jenetics.prog.op.Program
- toString() - Method in class io.jenetics.prog.op.Var
- toString() - Method in record class io.jenetics.prog.regression.Sampling.Result
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.RouletteWheelSelector
- toString() - Method in record class io.jenetics.ShiftMutator.Range
-
Returns a string representation of this record class.
- toString() - Method in record class io.jenetics.ShuffleMutator.Range
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.SinglePointCrossover
- toString() - Method in record class io.jenetics.stat.DoubleMoments
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.stat.DoubleMomentStatistics
- toString() - Method in record class io.jenetics.stat.DoubleSummary
-
Returns a string representation of this record class.
- toString() - Method in record class io.jenetics.stat.IntMoments
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.stat.IntMomentStatistics
- toString() - Method in record class io.jenetics.stat.IntSummary
-
Returns a string representation of this record class.
- toString() - Method in record class io.jenetics.stat.LongMoments
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.stat.LongMomentStatistics
- toString() - Method in record class io.jenetics.stat.LongSummary
-
Returns a string representation of this record class.
- toString() - Method in class io.jenetics.stat.MinMax
- toString() - Method in class io.jenetics.stat.Quantile
- toString() - Method in class io.jenetics.TournamentSelector
- toString() - Method in class io.jenetics.TruncationSelector
- toString() - Method in class io.jenetics.util.CharSeq
- toString() - Method in class io.jenetics.util.DoubleRange
- toString() - Method in class io.jenetics.util.IntRange
- toString() - Method in class io.jenetics.util.LongRange
- toString() - Method in class io.jenetics.util.NanoClock
- toString() - Method in class io.jenetics.xml.stream.Reader
- toString(Tree<?, ?>) - Static method in interface io.jenetics.ext.util.Tree
-
Return a string representation of the given tree, like the following example.
- toString(String) - Method in interface io.jenetics.util.Seq
-
Create a string representation of the given sequence.
- toString(String, String, String) - Method in interface io.jenetics.util.Seq
-
Create a string representation of the given sequence.
- toString(List<? extends Cfg.Symbol<?>>) - Static method in class io.jenetics.ext.grammar.SentenceGenerator
-
Converts a list of symbols to a string, by concatenating the names of the given symbols.
- totalGenerations() - Method in class io.jenetics.engine.EvolutionResult
-
Return the generation count evaluated so far.
- toTree() - Method in class io.jenetics.prog.op.MathExpr
-
Deprecated, for removal: This API element is subject to removal in a future version.Will be removed, use
MathExpr.tree()
instead - toTree(ISeq<? extends FlatTree<? extends Op<A>, ?>>, ISeq<? extends Op<A>>) - Static method in class io.jenetics.prog.op.Program
-
Creates a valid program tree from the given flattened sequence of op nodes.
- toTreeNode() - Method in class io.jenetics.prog.ProgramGene
-
Creates a new
TreeNode
from this program gene. - toUniquePopulation() - Static method in class io.jenetics.engine.EvolutionResult
-
Return a mapping function, which removes duplicate individuals from the population and replaces it with newly created one by the existing genotype factory.
- toUniquePopulation(int) - Static method in class io.jenetics.engine.EvolutionResult
-
Return a mapping function, which removes duplicate individuals from the population and replaces it with newly created one by the existing genotype factory.
- toUniquePopulation(Factory<Genotype<G>>) - Static method in class io.jenetics.engine.EvolutionResult
-
Return a mapping function, which removes duplicate individuals from the population and replaces it with newly created one by the given genotype
factory
. - toUniquePopulation(Factory<Genotype<G>>, int) - Static method in class io.jenetics.engine.EvolutionResult
-
Return a mapping function, which removes duplicate individuals from the population and replaces it with newly created one by the given genotype
factory
. - TournamentSelector<G,
C> - Class in io.jenetics -
In tournament selection the best individual from a random sample of s individuals is chosen from the population Pg.
- TournamentSelector() - Constructor for class io.jenetics.TournamentSelector
-
Create a tournament selector with sample size two.
- TournamentSelector(int) - Constructor for class io.jenetics.TournamentSelector
-
Create a tournament selector with the give sample size.
- TournamentSelector(Comparator<? super Phenotype<G, C>>, int) - Constructor for class io.jenetics.TournamentSelector
-
Create a tournament selector with the give
comparator
and sample size. - tree() - Method in class io.jenetics.ext.rewriting.TreeMatcher
-
Return the matching tree.
- tree() - Method in class io.jenetics.ext.rewriting.TreeMatchResult
-
The node (tree), which has been matched by some pattern.
- tree() - Method in class io.jenetics.prog.op.MathExpr
-
Return the operation tree underlying
this
math expression. - tree() - Method in class io.jenetics.prog.op.Program
-
Return the underlying expression tree.
- Tree<V,
T> - Interface in io.jenetics.ext.util -
General purpose tree structure.
- TREE - Static variable in class io.jenetics.ext.util.TreeFormatter
-
Formats a given tree to a tree string representation.
- Tree.Path - Class in io.jenetics.ext.util
-
This class represents the path to child within a given tree.
- TreeChromosome<A,
G> - Interface in io.jenetics.ext -
Chromosome for tree shaped genes.
- TreeCrossover<G,
C> - Class in io.jenetics.ext -
Abstract implementation of tree base crossover recombinator.
- TreeCrossover(double) - Constructor for class io.jenetics.ext.TreeCrossover
-
Constructs a tree crossover with a given recombination probability.
- TreeFormatter - Class in io.jenetics.ext.util
-
Definition of different tree formatter strategies.
- TreeFormatter() - Constructor for class io.jenetics.ext.util.TreeFormatter
- TreeGene<A,
G> - Interface in io.jenetics.ext -
Representation of tree shaped gene.
- TreeMatcher<V> - Class in io.jenetics.ext.rewriting
-
Implementation of a pattern-based tree matcher.
- TreeMatchResult<V> - Class in io.jenetics.ext.rewriting
-
The result of a tree match operation.
- TreeMutator<A,
G, - Class in io.jenetics.extC> -
Abstract class for mutating tree chromosomes.
- TreeMutator() - Constructor for class io.jenetics.ext.TreeMutator
- TreeMutator(double) - Constructor for class io.jenetics.ext.TreeMutator
- TreeNode<T> - Class in io.jenetics.ext.util
-
A general purpose node in a tree data-structure.
- TreePattern<V> - Class in io.jenetics.ext.rewriting
-
This class serves two purposes.
- TreePattern(Tree<TreePattern.Decl<V>, ?>) - Constructor for class io.jenetics.ext.rewriting.TreePattern
-
Create a new tree-pattern object from the given pattern tree.
- TreePattern.Decl<V> - Interface in io.jenetics.ext.rewriting
-
A sealed interface, which constitutes the nodes of a pattern tree.
- TreePattern.Val<V> - Record Class in io.jenetics.ext.rewriting
-
This class represents a constant pattern value, which can be part of a whole subtree.
- TreePattern.Var<V> - Record Class in io.jenetics.ext.rewriting
-
Represents a placeholder (variable) for an arbitrary subtree.
- TreeRewriteAlterer<A,
G, - Class in io.jenetics.extC> -
This alterer uses a
TreeRewriter
for altering theTreeChromosome
. - TreeRewriteAlterer(TreeRewriter<A>) - Constructor for class io.jenetics.ext.TreeRewriteAlterer
-
Create a new alterer with the given
rewriter
. - TreeRewriteAlterer(TreeRewriter<A>, double) - Constructor for class io.jenetics.ext.TreeRewriteAlterer
-
Create a new alterer with the given
rewriter
. - TreeRewriteAlterer(TreeRewriter<A>, int) - Constructor for class io.jenetics.ext.TreeRewriteAlterer
-
Create a new alterer with the given
rewriter
and given rewritelimit
. - TreeRewriteAlterer(TreeRewriter<A>, int, double) - Constructor for class io.jenetics.ext.TreeRewriteAlterer
-
Create a new alterer with the given
rewriter
and given rewritelimit
. - TreeRewriter<V> - Interface in io.jenetics.ext.rewriting
-
Interface for rewriting a given tree.
- TreeRewriteRule<V> - Class in io.jenetics.ext.rewriting
-
Represents a tree rewrite rule.
- TreeRewriteRule(TreePattern<V>, TreePattern<V>) - Constructor for class io.jenetics.ext.rewriting.TreeRewriteRule
-
Create a new rewrite rule from the given matching (
left
) and replacement (right
) pattern. - triangular(double) - Static method in class io.jenetics.stat.Samplers
-
Return a new sampler for a normalized triangle distribution with the points
[0, c, 1]
. - triangular(double, double, double) - Static method in class io.jenetics.stat.Samplers
-
Create a new sampler for a triangle distribution with the given parameters.
- trim(int, ElementComparator<? super T>, ElementDistance<? super T>, ToIntFunction<? super T>) - Method in class io.jenetics.ext.moea.ParetoFront
-
Trims
this
pareto front to the given size. - TRS<V> - Class in io.jenetics.ext.rewriting
-
This class represents a Tree Rewrite System, which consists of a set of Tree Rewrite Rules.
- TRS(ISeq<TreeRewriteRule<V>>) - Constructor for class io.jenetics.ext.rewriting.TRS
-
Create a new TRS from the given rewrite rules.
- TRUE - Enum constant in enum class io.jenetics.BitGene
- TRUE - Static variable in enum class io.jenetics.prog.op.BoolOp
-
Represents the constant
true
. - TruncationSelector<G,
C> - Class in io.jenetics -
In truncation selection, individuals are sorted according to their fitness.
- TruncationSelector() - Constructor for class io.jenetics.TruncationSelector
-
Create a new TruncationSelector object.
- TruncationSelector(int) - Constructor for class io.jenetics.TruncationSelector
-
Create a new
TruncationSelector
object, where the worst selected individual has rankn
. - type() - Method in class io.jenetics.prog.op.ConstRewriter
-
Return the operation type this rewriter is working on.
- type() - Method in class io.jenetics.xml.Writers.DoubleChromosome
U
- UFTournamentSelector<G,
C> - Class in io.jenetics.ext.moea -
Unique fitness based tournament selection.
- UFTournamentSelector(Comparator<? super C>, ElementComparator<? super C>, ElementDistance<? super C>, ToIntFunction<? super C>) - Constructor for class io.jenetics.ext.moea.UFTournamentSelector
-
Creates a new
UFTournamentSelector
with the functions needed for handling the multi-objective result typeC
. - UNIFORM - Static variable in interface io.jenetics.ShiftMutator.RangeRandom
-
Random shift range generator, which creates shifter with uniformly distributed shifting points.
- UNIFORM - Static variable in interface io.jenetics.ShuffleMutator.RangeRandom
-
Random range generator, which creates ranges with uniformly distributed range indexes.
- UNIFORM - Static variable in interface io.jenetics.stat.Sampler
-
Default uniform distribution by calling
RandomGenerator.nextDouble(double, double)
. - UniformCrossover<G,
C> - Class in io.jenetics -
The uniform crossover uses swaps single genes between two chromosomes, instead of whole ranges as in single- and multipoint crossover.
- UniformCrossover() - Constructor for class io.jenetics.UniformCrossover
-
Create a new universal crossover instance.
- UniformCrossover(double) - Constructor for class io.jenetics.UniformCrossover
-
Create a new universal crossover instance.
- UniformCrossover(double, double) - Constructor for class io.jenetics.UniformCrossover
-
Create a new universal crossover instance.
- UniformOderBasedCrossover<T,
C> - Class in io.jenetics -
The
UniformOderBasedCrossover
guarantees that allGene
s are found exactly once in each chromosome. - UniformOderBasedCrossover(double) - Constructor for class io.jenetics.UniformOderBasedCrossover
-
Create a new UniformOrderBasedCrossover instance
- upcast(ISeq<B>) - Static method in interface io.jenetics.util.ISeq
-
Allows a safe (without compiler warning) upcast from
B
toA
. - using(Supplier<? extends R>, Consumer<? super R>) - Static method in class io.jenetics.util.RandomRegistry
-
Executes the consumer code using the given
random
generator supplier. - using(RandomGeneratorFactory<? extends R>, Consumer<? super R>) - Static method in class io.jenetics.util.RandomRegistry
-
Executes the consumer code using the given
random
generator. - using(R, Consumer<? super R>) - Static method in class io.jenetics.util.RandomRegistry
-
Executes the consumer code using the given
random
generator.
V
- Val<T> - Class in io.jenetics.prog.op
-
This is the sealed base class for unmodifiable values.
- Val(V) - Constructor for record class io.jenetics.ext.rewriting.TreePattern.Val
-
Creates an instance of a
Val
record class. - validAlleles() - Method in class io.jenetics.EnumGene
-
Return sequence of the valid alleles where this gene is a part of.
- validAlleles() - Method in class io.jenetics.PermutationChromosome
-
Return the sequence of the valid alleles of this chromosome.
- validChars() - Method in class io.jenetics.CharacterGene
-
Return a (unmodifiable) set of valid characters.
- value() - Method in record class io.jenetics.ext.grammar.Cfg.Terminal
-
Returns the value of the
value
record component. - value() - Method in record class io.jenetics.ext.rewriting.TreePattern.Val
-
Returns the value of the
value
record component. - value() - Method in interface io.jenetics.ext.TreeGene
- value() - Method in record class io.jenetics.ext.util.CsvSupport.Quote
-
Returns the value of the
value
record component. - value() - Method in record class io.jenetics.ext.util.CsvSupport.Separator
-
Returns the value of the
value
record component. - value() - Method in class io.jenetics.ext.util.FlatTreeNode
- value() - Method in interface io.jenetics.ext.util.Tree
-
Return the value of the current
Tree
node. - value() - Method in class io.jenetics.ext.util.TreeNode
-
Return the node value
- value() - Method in class io.jenetics.prog.op.Const
- value() - Method in class io.jenetics.prog.op.EphemeralConst
-
Fixes and returns the constant value.
- value() - Method in class io.jenetics.prog.op.Val
-
Return the constant value.
- value() - Method in class io.jenetics.stat.Quantile
-
Return the computed quantile value.
- value(T) - Method in class io.jenetics.ext.util.TreeNode
-
Sets the user object for this node.
- valueOf(String) - Static method in enum class io.jenetics.BitGene
-
Returns the enum constant of this class with the specified name.
- valueOf(String) - Static method in enum class io.jenetics.ext.grammar.SentenceGenerator.Expansion
-
Returns the enum constant of this class with the specified name.
- valueOf(String) - Static method in enum class io.jenetics.Optimize
-
Returns the enum constant of this class with the specified name.
- valueOf(String) - Static method in enum class io.jenetics.prog.op.BoolOp
-
Returns the enum constant of this class with the specified name.
- valueOf(String) - Static method in enum class io.jenetics.prog.op.MathOp
-
Returns the enum constant of this class with the specified name.
- values() - Static method in enum class io.jenetics.BitGene
-
Returns an array containing the constants of this enum class, in the order they are declared.
- values() - Static method in enum class io.jenetics.ext.grammar.SentenceGenerator.Expansion
-
Returns an array containing the constants of this enum class, in the order they are declared.
- values() - Method in record class io.jenetics.ext.util.CsvSupport.ColumnIndexes
-
Returns the value of the
values
record component. - values() - Static method in enum class io.jenetics.Optimize
-
Returns an array containing the constants of this enum class, in the order they are declared.
- values() - Static method in enum class io.jenetics.prog.op.BoolOp
-
Returns an array containing the constants of this enum class, in the order they are declared.
- values() - Static method in enum class io.jenetics.prog.op.MathOp
-
Returns an array containing the constants of this enum class, in the order they are declared.
- Var - Search tag in package io.jenetics.prog.op
- Section
- Var<T> - Class in io.jenetics.prog.op
-
Represents the program variables.
- Var(String) - Constructor for record class io.jenetics.ext.rewriting.TreePattern.Var
-
Creates an instance of a
Var
record class. - variance() - Method in record class io.jenetics.stat.DoubleMoments
-
Returns the value of the
variance
record component. - variance() - Method in record class io.jenetics.stat.IntMoments
-
Returns the value of the
variance
record component. - variance() - Method in record class io.jenetics.stat.LongMoments
-
Returns the value of the
variance
record component. - variance() - Method in class io.jenetics.stat.DoubleMomentStatistics
-
Return the variance of values recorded, or
Double.NaN
if no values have been recorded. - variance() - Method in class io.jenetics.stat.IntMomentStatistics
-
Return the variance of values recorded, or
Double.NaN
if no values have been recorded. - variance() - Method in class io.jenetics.stat.LongMomentStatistics
-
Return the variance of values recorded, or
Double.NaN
if no values have been recorded. - vars() - Method in class io.jenetics.ext.rewriting.TreeMatchResult
-
The variables involved while matching the tree
TreeMatchResult.tree()
. - vars() - Method in class io.jenetics.ext.rewriting.TreePattern
-
Return the unmodifiable set of variables, defined in
this
pattern. - vars() - Method in class io.jenetics.prog.op.MathExpr
-
Return the variable list of this math expression.
- Vec<T> - Interface in io.jenetics.ext.moea
-
The
Vec
interface represents the fitness result of a multi-objective fitness function. - VecFactory<T> - Interface in io.jenetics.ext.moea
-
This interface allows creating a vector object from a given array type
T
. - Verifiable - Interface in io.jenetics.util
-
This interface lets you check an object for validity.
- viewOf(BaseSeq<? extends T>) - Static method in interface io.jenetics.util.Seq
-
Returns a sequence backed by the specified
seq
. - viewOf(List<? extends T>) - Static method in interface io.jenetics.util.Seq
-
Returns a sequence backed by the specified list.
- viewOf(T[]) - Static method in interface io.jenetics.util.Seq
-
Returns a fixed-size sequence backed by the specified array.
W
- WeaselMutator<G,
C> - Class in io.jenetics.ext -
Mutator implementation which is part of the Weasel program algorithm.
- WeaselMutator() - Constructor for class io.jenetics.ext.WeaselMutator
-
Create a new weasel mutator with the default mutation probability of
0.05
. - WeaselMutator(double) - Constructor for class io.jenetics.ext.WeaselMutator
-
Create a new weasel mutator with the given mutation probability.
- WeaselProgram<G,
C> - Class in io.jenetics.ext -
Configures the evolution engine to execute the Weasel program algorithm.
- WeaselProgram() - Constructor for class io.jenetics.ext.WeaselProgram
-
Create a new weasel program setup with the default mutation probability of
0.05
. - WeaselProgram(double) - Constructor for class io.jenetics.ext.WeaselProgram
-
Create a new weasel program setup with the give mutation probability.
- WeaselSelector<G,
C> - Class in io.jenetics.ext -
Selector implementation which is part of the Weasel program algorithm.
- WeaselSelector() - Constructor for class io.jenetics.ext.WeaselSelector
- with(Supplier<? extends R>, Function<? super R, ? extends T>) - Static method in class io.jenetics.util.RandomRegistry
-
Opens a new scope with the given random generator supplier and executes the given function within it.
- with(RandomGeneratorFactory<? extends R>, Function<? super R, ? extends T>) - Static method in class io.jenetics.util.RandomRegistry
-
Opens a new scope with the given random generator factory and executes the given function within it.
- with(R, Function<? super R, ? extends T>) - Static method in class io.jenetics.util.RandomRegistry
-
Opens a new scope with the given random generator and executes the given function within it.
- withFitness(C) - Method in class io.jenetics.Phenotype
-
Return a new
Phenotype
object with the given raw fitness value. - withGeneration(long) - Method in class io.jenetics.Phenotype
-
Return a new
Phenotype
object with the given generation. - withZone(ZoneId) - Method in class io.jenetics.util.NanoClock
- worst() - Method in enum class io.jenetics.Optimize
-
Return a
null
-friendly function which returns the worst element of two values. - worst(C, C) - Method in enum class io.jenetics.Optimize
-
Return the worst value, according to this optimization direction.
- worstFitness() - Method in class io.jenetics.engine.EvolutionResult
-
Return the worst population fitness.
- worstPhenotype() - Method in class io.jenetics.engine.EvolutionResult
-
Return the worst
Phenotype
of the result population. - write(OutputStream, BitChromosome) - Static method in class io.jenetics.xml.Writers.BitChromosome
-
Write the given
BitChromosome
to the given output stream. - write(OutputStream, CharacterChromosome) - Static method in class io.jenetics.xml.Writers.CharacterChromosome
-
Write the given
CharacterChromosome
to the given output stream. - write(OutputStream, CharacterChromosome, String) - Static method in class io.jenetics.xml.Writers.CharacterChromosome
-
Write the given
CharacterChromosome
to the given output stream. - write(OutputStream, DoubleChromosome) - Static method in class io.jenetics.xml.Writers.DoubleChromosome
-
Write the given
DoubleChromosome
to the given output stream. - write(OutputStream, DoubleChromosome, String) - Static method in class io.jenetics.xml.Writers.DoubleChromosome
-
Write the given
DoubleChromosome
to the given output stream. - write(OutputStream, Genotype<G>, Writer<? super C>) - Static method in class io.jenetics.xml.Writers.Genotype
-
Write the given
Genotype
to the given output stream. - write(OutputStream, Genotype<G>, String, Writer<? super C>) - Static method in class io.jenetics.xml.Writers.Genotype
-
Write the given
Genotype
to the given output stream. - write(OutputStream, IntegerChromosome) - Static method in class io.jenetics.xml.Writers.IntegerChromosome
-
Write the given
IntegerChromosome
to the given output stream. - write(OutputStream, IntegerChromosome, String) - Static method in class io.jenetics.xml.Writers.IntegerChromosome
-
Write the given
IntegerChromosome
to the given output stream. - write(OutputStream, LongChromosome) - Static method in class io.jenetics.xml.Writers.LongChromosome
-
Write the given
LongChromosome
to the given output stream. - write(OutputStream, LongChromosome, String) - Static method in class io.jenetics.xml.Writers.LongChromosome
-
Write the given
LongChromosome
to the given output stream. - write(OutputStream, PermutationChromosome<A>) - Static method in class io.jenetics.xml.Writers.PermutationChromosome
-
Write the given
PermutationChromosome
to the given output stream. - write(OutputStream, PermutationChromosome<A>, Writer<? super A>) - Static method in class io.jenetics.xml.Writers.PermutationChromosome
-
Write the given
PermutationChromosome
to the given output stream. - write(OutputStream, PermutationChromosome<A>, String) - Static method in class io.jenetics.xml.Writers.PermutationChromosome
-
Write the given
PermutationChromosome
to the given output stream. - write(OutputStream, PermutationChromosome<A>, String, Writer<? super A>) - Static method in class io.jenetics.xml.Writers.PermutationChromosome
-
Write the given
PermutationChromosome
to the given output stream. - write(OutputStream, Collection<Genotype<G>>, Writer<? super C>) - Static method in class io.jenetics.xml.Writers.Genotypes
-
Write the given
Genotype
to the given output stream. - write(OutputStream, Collection<Genotype<G>>, Writer<? super C>) - Static method in class io.jenetics.xml.Writers
-
Write the given
Genotype
to the given output stream. - write(OutputStream, Collection<Genotype<G>>, String, Writer<? super C>) - Static method in class io.jenetics.xml.Writers.Genotypes
-
Write the given
Genotype
to the given output stream. - write(Object, File) - Method in class io.jenetics.util.IO
-
Write the (serializable) object to the given file.
- write(Object, OutputStream) - Method in class io.jenetics.util.IO
-
Write the (serializable) object to the given output stream.
- write(Object, String) - Method in class io.jenetics.util.IO
-
Write the (serializable) object to the given path.
- write(Object, Path) - Method in class io.jenetics.util.IO
-
Write the (serializable) object to the given path.
- write(XMLStreamWriter, T) - Method in interface io.jenetics.xml.stream.Writer
-
Write the data of type
T
to the given XML stream writer. - writer() - Static method in class io.jenetics.xml.Writers.BitChromosome
-
Return a
Writer
forBitChromosome
objects. - writer() - Static method in class io.jenetics.xml.Writers.CharacterChromosome
-
Return a
Writer
forCharacterChromosome
objects. - writer() - Static method in class io.jenetics.xml.Writers.DoubleChromosome
-
Return a
Writer
forDoubleChromosome
objects. - writer() - Static method in class io.jenetics.xml.Writers.IntegerChromosome
-
Return a
Writer
forIntegerChromosome
objects. - writer() - Static method in class io.jenetics.xml.Writers.LongChromosome
-
Return a
Writer
forLongChromosome
objects. - writer() - Static method in class io.jenetics.xml.Writers.PermutationChromosome
-
Create a writer for permutation-chromosomes.
- writer(Writer<? super A>) - Static method in class io.jenetics.xml.Writers.PermutationChromosome
-
Create a writer for permutation-chromosomes.
- writer(Writer<? super C>) - Static method in class io.jenetics.xml.Writers.Genotype
-
Create a writer for genotypes of arbitrary chromosomes.
- writer(Writer<? super C>) - Static method in class io.jenetics.xml.Writers.Genotypes
-
Create a writer for genotypes of arbitrary chromosomes.
- writer(Writer<? super Double>) - Static method in class io.jenetics.xml.Writers.DoubleChromosome
-
Return a
Writer
forDoubleChromosome
objects. - writer(Writer<? super Integer>) - Static method in class io.jenetics.xml.Writers.IntegerChromosome
-
Return a
Writer
forIntegerChromosome
objects. - writer(Writer<? super Long>) - Static method in class io.jenetics.xml.Writers.LongChromosome
-
Return a
Writer
forLongChromosome
objects. - writer(OutputStream) - Static method in class io.jenetics.xml.stream.XML
-
Create a new
XMLStreamWriter
from the given output stream. - writer(OutputStream, String) - Static method in class io.jenetics.xml.stream.XML
-
Create a new
XMLStreamWriter
from the given output stream. - writer(String, Writer<? super A>) - Static method in class io.jenetics.xml.Writers.BoundedChromosome
-
Create a bounded chromosome writer with the given configuration.
- Writer<T> - Interface in io.jenetics.xml.stream
-
XML writer interface, used for writing objects in XML format.
- Writers - Class in io.jenetics.xml
-
This class contains static fields and methods, for creating chromosome- and genotype writers for different gene types.
- Writers.BitChromosome - Class in io.jenetics.xml
-
This class contains static writer methods for
BitChromosome
objects. - Writers.BoundedChromosome - Class in io.jenetics.xml
-
This class contains static writer methods for
BoundedChromosome
objects. - Writers.CharacterChromosome - Class in io.jenetics.xml
-
This class contains static writer methods for
CharacterChromosome
objects. - Writers.DoubleChromosome - Class in io.jenetics.xml
-
This class contains static writer methods for
DoubleChromosome
objects. - Writers.Genotype - Class in io.jenetics.xml
-
This class contains static writer methods for
Genotype
objects. - Writers.Genotypes - Class in io.jenetics.xml
-
This class contains static writer methods for
Genotype
objects. - Writers.IntegerChromosome - Class in io.jenetics.xml
-
This class contains static writer methods for
IntegerChromosome
objects. - Writers.LongChromosome - Class in io.jenetics.xml
-
This class contains static writer methods for
LongChromosome
objects. - Writers.PermutationChromosome - Class in io.jenetics.xml
-
This class contains static writer methods for
PermutationChromosome
objects.
X
- XML - Class in io.jenetics.xml.stream
-
This class contains helper methods for creating
XMLStreamReader
andXMLStreamWriter
objects. - xor(BitChromosome) - Method in class io.jenetics.BitChromosome
-
Returns a
BitChromosome
whose value is (this ^ other
). - XOR - Enum constant in enum class io.jenetics.prog.op.BoolOp
-
Exclusive or.
Z
- ZERO - Static variable in enum class io.jenetics.BitGene
- ZERO - Static variable in record class io.jenetics.engine.EvolutionDurations
-
Constant for zero evolution durations.
- ZERO - Static variable in record class io.jenetics.ext.util.CsvSupport.Quote
-
The zero '\0' character.
- zeros() - Method in class io.jenetics.BitChromosome
-
Return the indexes of the zeros of this bit-chromosome as stream.
_
- _genes - Variable in class io.jenetics.AbstractChromosome
-
Array of genes which forms the chromosome.
- _probability - Variable in class io.jenetics.AbstractAlterer
-
The altering probability.
- _reverter - Variable in class io.jenetics.ProbabilitySelector
- _sorted - Variable in class io.jenetics.ProbabilitySelector
- _valid - Variable in class io.jenetics.AbstractChromosome
-
Indicates whether this chromosome is valid or not.
All Classes and Interfaces|All Packages|Constant Field Values|Serialized Form
Codec.combine(Codec, Codec, BiFunction)
instead