Fixed checkstyle warnings.
These warnings correspond to redundant modifiers (public, static, ...). They are identified by recent versions of checkstyle, in particular the one shipped with Eclipse. They are not detected by our maven-checkstyle-plugin yet because it is not the latest one and still depends on an older version of checkstyle.
This commit is contained in:
parent
e10556ec68
commit
bf7e9d505a
|
@ -1237,7 +1237,7 @@ public class DerivativeStructure implements RealFieldElement<DerivativeStructure
|
|||
* @param order derivation order
|
||||
* @param data partial derivatives
|
||||
*/
|
||||
public DataTransferObject(final int variables, final int order, final double[] data) {
|
||||
DataTransferObject(final int variables, final int order, final double[] data) {
|
||||
this.variables = variables;
|
||||
this.order = order;
|
||||
this.data = data;
|
||||
|
|
|
@ -275,7 +275,7 @@ class BicubicFunction implements BivariateFunction {
|
|||
*
|
||||
* @param coeff Spline coefficients.
|
||||
*/
|
||||
public BicubicFunction(double[] coeff) {
|
||||
BicubicFunction(double[] coeff) {
|
||||
a = new double[N][N];
|
||||
for (int j = 0; j < N; j++) {
|
||||
final double[] aJ = a[j];
|
||||
|
|
|
@ -334,7 +334,7 @@ public class InterpolatingMicrosphere {
|
|||
* @param n Normal vector characterizing a surface element
|
||||
* of the microsphere. No copy is made.
|
||||
*/
|
||||
public Facet(double[] n) {
|
||||
Facet(double[] n) {
|
||||
normal = n;
|
||||
}
|
||||
|
||||
|
@ -361,8 +361,7 @@ public class InterpolatingMicrosphere {
|
|||
* @param illumination Illumination.
|
||||
* @param sample Data value.
|
||||
*/
|
||||
public FacetData(double illumination,
|
||||
double sample) {
|
||||
FacetData(double illumination, double sample) {
|
||||
this.illumination = illumination;
|
||||
this.sample = sample;
|
||||
}
|
||||
|
|
|
@ -453,7 +453,7 @@ class TricubicFunction
|
|||
/**
|
||||
* @param aV List of spline coefficients.
|
||||
*/
|
||||
public TricubicFunction(double[] aV) {
|
||||
TricubicFunction(double[] aV) {
|
||||
for (int i = 0; i < N; i++) {
|
||||
for (int j = 0; j < N; j++) {
|
||||
for (int k = 0; k < N; k++) {
|
||||
|
|
|
@ -269,7 +269,7 @@ public class PolynomialsUtils {
|
|||
* @param v first exponent
|
||||
* @param w second exponent
|
||||
*/
|
||||
public JacobiKey(final int v, final int w) {
|
||||
JacobiKey(final int v, final int w) {
|
||||
this.v = v;
|
||||
this.w = w;
|
||||
}
|
||||
|
|
|
@ -379,7 +379,7 @@ public enum LocalizedFormats implements Localizable {
|
|||
* @param sourceFormat source English format to use when no
|
||||
* localized version is available
|
||||
*/
|
||||
private LocalizedFormats(final String sourceFormat) {
|
||||
LocalizedFormats(final String sourceFormat) {
|
||||
this.sourceFormat = sourceFormat;
|
||||
}
|
||||
|
||||
|
|
|
@ -50,7 +50,7 @@ public class GaussNewtonOptimizer implements LeastSquaresOptimizer {
|
|||
|
||||
/** The decomposition algorithm to use to solve the normal equations. */
|
||||
//TODO move to linear package and expand options?
|
||||
public static enum Decomposition {
|
||||
public enum Decomposition {
|
||||
/**
|
||||
* Solve by forming the normal equations (J<sup>T</sup>Jx=J<sup>T</sup>r) and
|
||||
* using the {@link LUDecomposition}.
|
||||
|
|
|
@ -527,7 +527,7 @@ public class IntervalsSet extends AbstractRegion<Euclidean1D, Euclidean1D> imple
|
|||
|
||||
/** Simple constructor.
|
||||
*/
|
||||
public SubIntervalsIterator() {
|
||||
SubIntervalsIterator() {
|
||||
|
||||
current = getFirstIntervalBoundary();
|
||||
|
||||
|
|
|
@ -130,7 +130,7 @@ public class OutlineExtractor {
|
|||
/** Simple constructor.
|
||||
* @param tolerance tolerance below which points are considered identical
|
||||
*/
|
||||
public BoundaryProjector(final double tolerance) {
|
||||
BoundaryProjector(final double tolerance) {
|
||||
this.projected = new PolygonsSet(new BSPTree<Euclidean2D>(Boolean.FALSE), tolerance);
|
||||
this.tolerance = tolerance;
|
||||
}
|
||||
|
|
|
@ -374,7 +374,7 @@ public class PolyhedronsSet extends AbstractRegion<Euclidean3D, Euclidean2D> {
|
|||
private class FacetsContributionVisitor implements BSPTreeVisitor<Euclidean3D> {
|
||||
|
||||
/** Simple constructor. */
|
||||
public FacetsContributionVisitor() {
|
||||
FacetsContributionVisitor() {
|
||||
setSize(0);
|
||||
setBarycenter((Point<Euclidean3D>) new Vector3D(0, 0, 0));
|
||||
}
|
||||
|
@ -560,7 +560,7 @@ public class PolyhedronsSet extends AbstractRegion<Euclidean3D, Euclidean2D> {
|
|||
* @param center center point of the rotation
|
||||
* @param rotation vectorial rotation
|
||||
*/
|
||||
public RotationTransform(final Vector3D center, final Rotation rotation) {
|
||||
RotationTransform(final Vector3D center, final Rotation rotation) {
|
||||
this.center = center;
|
||||
this.rotation = rotation;
|
||||
}
|
||||
|
@ -634,7 +634,7 @@ public class PolyhedronsSet extends AbstractRegion<Euclidean3D, Euclidean2D> {
|
|||
/** Build a translation transform.
|
||||
* @param translation translation vector
|
||||
*/
|
||||
public TranslationTransform(final Vector3D translation) {
|
||||
TranslationTransform(final Vector3D translation) {
|
||||
this.translation = translation;
|
||||
}
|
||||
|
||||
|
|
|
@ -377,7 +377,7 @@ public class SphericalCoordinates implements Serializable {
|
|||
* @param y ordinate
|
||||
* @param z height
|
||||
*/
|
||||
public DataTransferObject(final double x, final double y, final double z) {
|
||||
DataTransferObject(final double x, final double y, final double z) {
|
||||
this.x = x;
|
||||
this.y = y;
|
||||
this.z = z;
|
||||
|
|
|
@ -486,8 +486,8 @@ public class Line implements Hyperplane<Euclidean2D>, Embedding<Euclidean2D, Euc
|
|||
* @exception MathIllegalArgumentException if the transform is non invertible
|
||||
* @since 4.0
|
||||
*/
|
||||
public LineTransform(final double cXX, final double cYX, final double cXY,
|
||||
final double cYY, final double cX1, final double cY1)
|
||||
LineTransform(final double cXX, final double cYX, final double cXY,
|
||||
final double cYY, final double cX1, final double cY1)
|
||||
throws MathIllegalArgumentException {
|
||||
|
||||
this.cXX = cXX;
|
||||
|
|
|
@ -69,7 +69,7 @@ class NestedLoops {
|
|||
* @param tolerance tolerance below which points are considered identical
|
||||
* @since 3.3
|
||||
*/
|
||||
public NestedLoops(final double tolerance) {
|
||||
NestedLoops(final double tolerance) {
|
||||
this.surrounded = new ArrayList<NestedLoops>();
|
||||
this.tolerance = tolerance;
|
||||
}
|
||||
|
|
|
@ -361,7 +361,7 @@ public class PolygonsSet extends AbstractRegion<Euclidean2D, Euclidean1D> {
|
|||
/** Build a non-processed vertex not owned by any node yet.
|
||||
* @param location vertex location
|
||||
*/
|
||||
public Vertex(final Vector2D location) {
|
||||
Vertex(final Vector2D location) {
|
||||
this.location = location;
|
||||
this.incoming = null;
|
||||
this.outgoing = null;
|
||||
|
@ -463,7 +463,7 @@ public class PolygonsSet extends AbstractRegion<Euclidean2D, Euclidean1D> {
|
|||
* @param end end vertex
|
||||
* @param line line supporting the edge
|
||||
*/
|
||||
public Edge(final Vertex start, final Vertex end, final Line line) {
|
||||
Edge(final Vertex start, final Vertex end, final Line line) {
|
||||
|
||||
this.start = start;
|
||||
this.end = end;
|
||||
|
@ -906,10 +906,10 @@ public class PolygonsSet extends AbstractRegion<Euclidean2D, Euclidean1D> {
|
|||
* @param startNode node whose intersection with current node defines start point
|
||||
* @param endNode node whose intersection with current node defines end point
|
||||
*/
|
||||
public ConnectableSegment(final Vector2D start, final Vector2D end, final Line line,
|
||||
final BSPTree<Euclidean2D> node,
|
||||
final BSPTree<Euclidean2D> startNode,
|
||||
final BSPTree<Euclidean2D> endNode) {
|
||||
ConnectableSegment(final Vector2D start, final Vector2D end, final Line line,
|
||||
final BSPTree<Euclidean2D> node,
|
||||
final BSPTree<Euclidean2D> startNode,
|
||||
final BSPTree<Euclidean2D> endNode) {
|
||||
super(start, end, line);
|
||||
this.node = node;
|
||||
this.startNode = startNode;
|
||||
|
@ -996,7 +996,7 @@ public class PolygonsSet extends AbstractRegion<Euclidean2D, Euclidean1D> {
|
|||
/** Simple constructor.
|
||||
* @param tolerance tolerance for close nodes connection
|
||||
*/
|
||||
public SegmentsBuilder(final double tolerance) {
|
||||
SegmentsBuilder(final double tolerance) {
|
||||
this.tolerance = tolerance;
|
||||
this.segments = new ArrayList<ConnectableSegment>();
|
||||
}
|
||||
|
|
|
@ -46,7 +46,7 @@ class BoundaryProjector<S extends Space, T extends Space> implements BSPTreeVisi
|
|||
/** Simple constructor.
|
||||
* @param original original point
|
||||
*/
|
||||
public BoundaryProjector(final Point<S> original) {
|
||||
BoundaryProjector(final Point<S> original) {
|
||||
this.original = original;
|
||||
this.projected = null;
|
||||
this.leaf = null;
|
||||
|
|
|
@ -29,7 +29,7 @@ class BoundarySizeVisitor<S extends Space> implements BSPTreeVisitor<S> {
|
|||
|
||||
/** Simple constructor.
|
||||
*/
|
||||
public BoundarySizeVisitor() {
|
||||
BoundarySizeVisitor() {
|
||||
boundarySize = 0;
|
||||
}
|
||||
|
||||
|
|
|
@ -53,7 +53,7 @@ class Characterization<S extends Space> {
|
|||
* @param node current BSP tree node
|
||||
* @param sub sub-hyperplane to characterize
|
||||
*/
|
||||
public Characterization(final BSPTree<S> node, final SubHyperplane<S> sub) {
|
||||
Characterization(final BSPTree<S> node, final SubHyperplane<S> sub) {
|
||||
outsideTouching = null;
|
||||
insideTouching = null;
|
||||
outsideSplitters = new NodesSet<S>();
|
||||
|
|
|
@ -37,7 +37,7 @@ class InsideFinder<S extends Space> {
|
|||
/** Simple constructor.
|
||||
* @param region region on which to operate
|
||||
*/
|
||||
public InsideFinder(final Region<S> region) {
|
||||
InsideFinder(final Region<S> region) {
|
||||
this.region = region;
|
||||
plusFound = false;
|
||||
minusFound = false;
|
||||
|
|
|
@ -53,7 +53,7 @@ import org.apache.commons.math4.geometry.Space;
|
|||
public interface Region<S extends Space> {
|
||||
|
||||
/** Enumerate for the location of a point with respect to the region. */
|
||||
public static enum Location {
|
||||
enum Location {
|
||||
/** Code for points inside the partition. */
|
||||
INSIDE,
|
||||
|
||||
|
|
|
@ -299,7 +299,7 @@ public class RegionFactory<S extends Space> {
|
|||
* @param region1 region to subtract from
|
||||
* @param region2 region to subtract
|
||||
*/
|
||||
public DifferenceMerger(final Region<S> region1, final Region<S> region2) {
|
||||
DifferenceMerger(final Region<S> region1, final Region<S> region2) {
|
||||
this.region1 = region1.copySelf();
|
||||
this.region2 = region2.copySelf();
|
||||
}
|
||||
|
@ -367,7 +367,7 @@ public class RegionFactory<S extends Space> {
|
|||
/** Simple constructor.
|
||||
* @param inside inside/outside indicator to use for ambiguous nodes
|
||||
*/
|
||||
public VanishingToLeaf(final boolean inside) {
|
||||
VanishingToLeaf(final boolean inside) {
|
||||
this.inside = inside;
|
||||
}
|
||||
|
||||
|
|
|
@ -84,7 +84,7 @@ public interface SubHyperplane<S extends Space> {
|
|||
/** Class holding the results of the {@link #split split} method.
|
||||
* @param <U> Type of the embedding space.
|
||||
*/
|
||||
public static class SplitSubHyperplane<U extends Space> {
|
||||
class SplitSubHyperplane<U extends Space> {
|
||||
|
||||
/** Part of the sub-hyperplane on the plus side of the splitting hyperplane. */
|
||||
private final SubHyperplane<U> plus;
|
||||
|
|
|
@ -599,7 +599,7 @@ public class ArcsSet extends AbstractRegion<Sphere1D, Sphere1D> implements Itera
|
|||
|
||||
/** Simple constructor.
|
||||
*/
|
||||
public SubArcsIterator() {
|
||||
SubArcsIterator() {
|
||||
|
||||
firstStart = getFirstArcStart();
|
||||
current = firstStart;
|
||||
|
|
|
@ -304,7 +304,7 @@ public class Circle implements Hyperplane<Sphere2D>, Embedding<Sphere2D, Sphere1
|
|||
/** Build a transform from a {@code Rotation}.
|
||||
* @param rotation rotation to use
|
||||
*/
|
||||
public CircleTransform(final Rotation rotation) {
|
||||
CircleTransform(final Rotation rotation) {
|
||||
this.rotation = rotation;
|
||||
}
|
||||
|
||||
|
|
|
@ -52,7 +52,7 @@ class EdgesBuilder implements BSPTreeVisitor<Sphere2D> {
|
|||
* @param root tree root
|
||||
* @param tolerance below which points are consider to be identical
|
||||
*/
|
||||
public EdgesBuilder(final BSPTree<Sphere2D> root, final double tolerance) {
|
||||
EdgesBuilder(final BSPTree<Sphere2D> root, final double tolerance) {
|
||||
this.root = root;
|
||||
this.tolerance = tolerance;
|
||||
this.edgeToNode = new IdentityHashMap<Edge, BSPTree<Sphere2D>>();
|
||||
|
|
|
@ -44,9 +44,9 @@ class PropertiesComputer implements BSPTreeVisitor<Sphere2D> {
|
|||
private final List<Vector3D> convexCellsInsidePoints;
|
||||
|
||||
/** Simple constructor.
|
||||
* @param tolerance below which points are consider to be identical
|
||||
* @param tolerance below which points are consider to be identical
|
||||
*/
|
||||
public PropertiesComputer(final double tolerance) {
|
||||
PropertiesComputer(final double tolerance) {
|
||||
this.tolerance = tolerance;
|
||||
this.summedArea = 0;
|
||||
this.summedBarycenter = Vector3D.ZERO;
|
||||
|
|
|
@ -58,7 +58,7 @@ class BiDiagonalTransformer {
|
|||
* Build the transformation to bi-diagonal shape of a matrix.
|
||||
* @param matrix the matrix to transform.
|
||||
*/
|
||||
public BiDiagonalTransformer(RealMatrix matrix) {
|
||||
BiDiagonalTransformer(RealMatrix matrix) {
|
||||
|
||||
final int m = matrix.getRowDimension();
|
||||
final int n = matrix.getColumnDimension();
|
||||
|
|
|
@ -56,7 +56,7 @@ class HessenbergTransformer {
|
|||
* @param matrix matrix to transform
|
||||
* @throws NonSquareMatrixException if the matrix is not square
|
||||
*/
|
||||
public HessenbergTransformer(final RealMatrix matrix) {
|
||||
HessenbergTransformer(final RealMatrix matrix) {
|
||||
if (!matrix.isSquare()) {
|
||||
throw new NonSquareMatrixException(matrix.getRowDimension(),
|
||||
matrix.getColumnDimension());
|
||||
|
|
|
@ -625,7 +625,7 @@ public class MatrixUtils {
|
|||
/** Converted array. */
|
||||
private double[][] data;
|
||||
/** Simple constructor. */
|
||||
public FractionMatrixConverter() {
|
||||
FractionMatrixConverter() {
|
||||
super(Fraction.ZERO);
|
||||
}
|
||||
|
||||
|
@ -670,7 +670,7 @@ public class MatrixUtils {
|
|||
/** Converted array. */
|
||||
private double[][] data;
|
||||
/** Simple constructor. */
|
||||
public BigFractionMatrixConverter() {
|
||||
BigFractionMatrixConverter() {
|
||||
super(BigFraction.ZERO);
|
||||
}
|
||||
|
||||
|
|
|
@ -65,7 +65,7 @@ class SchurTransformer {
|
|||
* @param matrix matrix to transform
|
||||
* @throws NonSquareMatrixException if the matrix is not square
|
||||
*/
|
||||
public SchurTransformer(final RealMatrix matrix) {
|
||||
SchurTransformer(final RealMatrix matrix) {
|
||||
if (!matrix.isSquare()) {
|
||||
throw new NonSquareMatrixException(matrix.getRowDimension(),
|
||||
matrix.getColumnDimension());
|
||||
|
|
|
@ -380,7 +380,7 @@ public class SymmLQ
|
|||
* @param check {@code true} if self-adjointedness of both matrix and
|
||||
* preconditioner should be checked
|
||||
*/
|
||||
public State(final RealLinearOperator a,
|
||||
State(final RealLinearOperator a,
|
||||
final RealLinearOperator m,
|
||||
final RealVector b,
|
||||
final boolean goodb,
|
||||
|
|
|
@ -58,7 +58,7 @@ class TriDiagonalTransformer {
|
|||
* @param matrix Symmetrical matrix to transform.
|
||||
* @throws NonSquareMatrixException if the matrix is not square.
|
||||
*/
|
||||
public TriDiagonalTransformer(RealMatrix matrix) {
|
||||
TriDiagonalTransformer(RealMatrix matrix) {
|
||||
if (!matrix.isSquare()) {
|
||||
throw new NonSquareMatrixException(matrix.getRowDimension(),
|
||||
matrix.getColumnDimension());
|
||||
|
|
|
@ -42,7 +42,7 @@ import org.apache.commons.math4.util.MathUtils;
|
|||
public class KMeansPlusPlusClusterer<T extends Clusterable> extends Clusterer<T> {
|
||||
|
||||
/** Strategies to use for replacing an empty cluster. */
|
||||
public static enum EmptyClusterStrategy {
|
||||
public enum EmptyClusterStrategy {
|
||||
|
||||
/** Split the cluster with largest distance variance. */
|
||||
LARGEST_VARIANCE,
|
||||
|
|
|
@ -302,8 +302,7 @@ public class MapUtils {
|
|||
* @param neuron Neuron.
|
||||
* @param value Value.
|
||||
*/
|
||||
public PairNeuronDouble(Neuron neuron,
|
||||
double value) {
|
||||
PairNeuronDouble(Neuron neuron, double value) {
|
||||
this.neuron = neuron;
|
||||
this.value = value;
|
||||
}
|
||||
|
|
|
@ -317,7 +317,7 @@ public class ExpandableStatefulODE {
|
|||
* @param equation secondary differential equation
|
||||
* @param firstIndex index to use for the first element in the complete arrays
|
||||
*/
|
||||
public SecondaryComponent(final SecondaryEquations equation, final int firstIndex) {
|
||||
SecondaryComponent(final SecondaryEquations equation, final int firstIndex) {
|
||||
final int n = equation.getDimension();
|
||||
this.equation = equation;
|
||||
mapper = new EquationsMapper(firstIndex, n);
|
||||
|
|
|
@ -433,8 +433,8 @@ public class JacobianMatrices {
|
|||
* @exception DimensionMismatchException if there is a dimension mismatch between
|
||||
* the steps array {@code hY} and the equation dimension
|
||||
*/
|
||||
public MainStateJacobianWrapper(final FirstOrderDifferentialEquations ode,
|
||||
final double[] hY)
|
||||
MainStateJacobianWrapper(final FirstOrderDifferentialEquations ode,
|
||||
final double[] hY)
|
||||
throws DimensionMismatchException {
|
||||
this.ode = ode;
|
||||
this.hY = hY.clone();
|
||||
|
|
|
@ -357,7 +357,7 @@ public abstract class MultistepIntegrator extends AdaptiveStepsizeIntegrator {
|
|||
* @param nSteps number of steps of the multistep method (excluding the one being computed)
|
||||
* @param n problem dimension
|
||||
*/
|
||||
public NordsieckInitializer(final int nSteps, final int n) {
|
||||
NordsieckInitializer(final int nSteps, final int n) {
|
||||
this.count = 0;
|
||||
this.t = new double[nSteps];
|
||||
this.y = new double[nSteps][n];
|
||||
|
@ -442,7 +442,7 @@ public abstract class MultistepIntegrator extends AdaptiveStepsizeIntegrator {
|
|||
private static final long serialVersionUID = -1914085471038046418L;
|
||||
|
||||
/** Simple constructor. */
|
||||
public InitializationCompletedMarkerException() {
|
||||
InitializationCompletedMarkerException() {
|
||||
super((Throwable) null);
|
||||
}
|
||||
|
||||
|
|
|
@ -38,7 +38,7 @@ class ParameterConfiguration implements Serializable {
|
|||
* @param parameterName parameter name
|
||||
* @param hP parameter step
|
||||
*/
|
||||
public ParameterConfiguration(final String parameterName, final double hP) {
|
||||
ParameterConfiguration(final String parameterName, final double hP) {
|
||||
this.parameterName = parameterName;
|
||||
this.hP = hP;
|
||||
}
|
||||
|
|
|
@ -46,9 +46,9 @@ class ParameterJacobianWrapper implements ParameterJacobianProvider {
|
|||
* @param paramsAndSteps parameters and steps to compute the Jacobians df/dp
|
||||
* @see JacobianMatrices#setParameterStep(String, double)
|
||||
*/
|
||||
public ParameterJacobianWrapper(final FirstOrderDifferentialEquations fode,
|
||||
final ParameterizedODE pode,
|
||||
final ParameterConfiguration[] paramsAndSteps) {
|
||||
ParameterJacobianWrapper(final FirstOrderDifferentialEquations fode,
|
||||
final ParameterizedODE pode,
|
||||
final ParameterConfiguration[] paramsAndSteps) {
|
||||
this.fode = fode;
|
||||
this.pode = pode;
|
||||
this.hParam = new HashMap<String, Double>();
|
||||
|
|
|
@ -35,7 +35,7 @@ class ParameterizedWrapper implements ParameterizedODE {
|
|||
/** Simple constructor.
|
||||
* @param ode original first order differential equations
|
||||
*/
|
||||
public ParameterizedWrapper(final FirstOrderDifferentialEquations ode) {
|
||||
ParameterizedWrapper(final FirstOrderDifferentialEquations ode) {
|
||||
this.fode = ode;
|
||||
}
|
||||
|
||||
|
|
|
@ -50,7 +50,7 @@ package org.apache.commons.math4.ode.events;
|
|||
public interface EventHandler {
|
||||
|
||||
/** Enumerate for actions to be performed when an event occurs. */
|
||||
public enum Action {
|
||||
enum Action {
|
||||
|
||||
/** Stop indicator.
|
||||
* <p>This value should be used as the return value of the {@link
|
||||
|
|
|
@ -414,7 +414,7 @@ public class EventState {
|
|||
/** Simple constructor.
|
||||
* @param exception exception to wrap
|
||||
*/
|
||||
public LocalMaxCountExceededException(final MaxCountExceededException exception) {
|
||||
LocalMaxCountExceededException(final MaxCountExceededException exception) {
|
||||
wrapped = exception;
|
||||
}
|
||||
|
||||
|
|
|
@ -367,7 +367,7 @@ public class AdamsMoultonIntegrator extends AdamsIntegrator {
|
|||
* @param scaled current scaled first derivative
|
||||
* @param state state to correct (will be overwritten after visit)
|
||||
*/
|
||||
public Corrector(final double[] previous, final double[] scaled, final double[] state) {
|
||||
Corrector(final double[] previous, final double[] scaled, final double[] state) {
|
||||
this.previous = previous;
|
||||
this.scaled = scaled;
|
||||
this.after = state;
|
||||
|
|
|
@ -68,7 +68,7 @@ class ClassicalRungeKuttaStepInterpolator
|
|||
* interpolators by cloning an uninitialized model and latter initializing
|
||||
* the copy.
|
||||
*/
|
||||
public ClassicalRungeKuttaStepInterpolator() {
|
||||
ClassicalRungeKuttaStepInterpolator() {
|
||||
}
|
||||
|
||||
/** Copy constructor.
|
||||
|
@ -76,7 +76,7 @@ class ClassicalRungeKuttaStepInterpolator
|
|||
* copy: its arrays are separated from the original arrays of the
|
||||
* instance
|
||||
*/
|
||||
public ClassicalRungeKuttaStepInterpolator(final ClassicalRungeKuttaStepInterpolator interpolator) {
|
||||
ClassicalRungeKuttaStepInterpolator(final ClassicalRungeKuttaStepInterpolator interpolator) {
|
||||
super(interpolator);
|
||||
}
|
||||
|
||||
|
|
|
@ -97,7 +97,7 @@ class DormandPrince54StepInterpolator
|
|||
* prototyping design pattern to create the step interpolators by
|
||||
* cloning an uninitialized model and latter initializing the copy.
|
||||
*/
|
||||
public DormandPrince54StepInterpolator() {
|
||||
DormandPrince54StepInterpolator() {
|
||||
super();
|
||||
v1 = null;
|
||||
v2 = null;
|
||||
|
@ -111,7 +111,7 @@ class DormandPrince54StepInterpolator
|
|||
* copy: its arrays are separated from the original arrays of the
|
||||
* instance
|
||||
*/
|
||||
public DormandPrince54StepInterpolator(final DormandPrince54StepInterpolator interpolator) {
|
||||
DormandPrince54StepInterpolator(final DormandPrince54StepInterpolator interpolator) {
|
||||
|
||||
super(interpolator);
|
||||
|
||||
|
|
|
@ -227,7 +227,7 @@ class DormandPrince853StepInterpolator
|
|||
* prototyping design pattern to create the step interpolators by
|
||||
* cloning an uninitialized model and latter initializing the copy.
|
||||
*/
|
||||
public DormandPrince853StepInterpolator() {
|
||||
DormandPrince853StepInterpolator() {
|
||||
super();
|
||||
yDotKLast = null;
|
||||
v = null;
|
||||
|
@ -239,7 +239,7 @@ class DormandPrince853StepInterpolator
|
|||
* copy: its arrays are separated from the original arrays of the
|
||||
* instance
|
||||
*/
|
||||
public DormandPrince853StepInterpolator(final DormandPrince853StepInterpolator interpolator) {
|
||||
DormandPrince853StepInterpolator(final DormandPrince853StepInterpolator interpolator) {
|
||||
|
||||
super(interpolator);
|
||||
|
||||
|
|
|
@ -59,7 +59,7 @@ class EulerStepInterpolator
|
|||
* to create the step interpolators by cloning an uninitialized model
|
||||
* and later initializing the copy.
|
||||
*/
|
||||
public EulerStepInterpolator() {
|
||||
EulerStepInterpolator() {
|
||||
}
|
||||
|
||||
/** Copy constructor.
|
||||
|
@ -67,7 +67,7 @@ class EulerStepInterpolator
|
|||
* copy: its arrays are separated from the original arrays of the
|
||||
* instance
|
||||
*/
|
||||
public EulerStepInterpolator(final EulerStepInterpolator interpolator) {
|
||||
EulerStepInterpolator(final EulerStepInterpolator interpolator) {
|
||||
super(interpolator);
|
||||
}
|
||||
|
||||
|
|
|
@ -75,7 +75,7 @@ class GillStepInterpolator
|
|||
* to create the step interpolators by cloning an uninitialized model
|
||||
* and later initializing the copy.
|
||||
*/
|
||||
public GillStepInterpolator() {
|
||||
GillStepInterpolator() {
|
||||
}
|
||||
|
||||
/** Copy constructor.
|
||||
|
@ -83,7 +83,7 @@ class GillStepInterpolator
|
|||
* copy: its arrays are separated from the original arrays of the
|
||||
* instance
|
||||
*/
|
||||
public GillStepInterpolator(final GillStepInterpolator interpolator) {
|
||||
GillStepInterpolator(final GillStepInterpolator interpolator) {
|
||||
super(interpolator);
|
||||
}
|
||||
|
||||
|
|
|
@ -107,7 +107,7 @@ class GraggBulirschStoerStepInterpolator
|
|||
* This constructor should not be used directly, it is only intended
|
||||
* for the serialization process.
|
||||
*/
|
||||
public GraggBulirschStoerStepInterpolator() {
|
||||
GraggBulirschStoerStepInterpolator() {
|
||||
y0Dot = null;
|
||||
y1 = null;
|
||||
y1Dot = null;
|
||||
|
@ -129,12 +129,12 @@ class GraggBulirschStoerStepInterpolator
|
|||
* @param primaryMapper equations mapper for the primary equations set
|
||||
* @param secondaryMappers equations mappers for the secondary equations sets
|
||||
*/
|
||||
public GraggBulirschStoerStepInterpolator(final double[] y, final double[] y0Dot,
|
||||
final double[] y1, final double[] y1Dot,
|
||||
final double[][] yMidDots,
|
||||
final boolean forward,
|
||||
final EquationsMapper primaryMapper,
|
||||
final EquationsMapper[] secondaryMappers) {
|
||||
GraggBulirschStoerStepInterpolator(final double[] y, final double[] y0Dot,
|
||||
final double[] y1, final double[] y1Dot,
|
||||
final double[][] yMidDots,
|
||||
final boolean forward,
|
||||
final EquationsMapper primaryMapper,
|
||||
final EquationsMapper[] secondaryMappers) {
|
||||
|
||||
super(y, forward, primaryMapper, secondaryMappers);
|
||||
this.y0Dot = y0Dot;
|
||||
|
@ -151,8 +151,7 @@ class GraggBulirschStoerStepInterpolator
|
|||
* copy: its arrays are separated from the original arrays of the
|
||||
* instance
|
||||
*/
|
||||
public GraggBulirschStoerStepInterpolator
|
||||
(final GraggBulirschStoerStepInterpolator interpolator) {
|
||||
GraggBulirschStoerStepInterpolator(final GraggBulirschStoerStepInterpolator interpolator) {
|
||||
|
||||
super(interpolator);
|
||||
|
||||
|
|
|
@ -45,7 +45,7 @@ class HighamHall54StepInterpolator
|
|||
* to create the step interpolators by cloning an uninitialized model
|
||||
* and later initializing the copy.
|
||||
*/
|
||||
public HighamHall54StepInterpolator() {
|
||||
HighamHall54StepInterpolator() {
|
||||
super();
|
||||
}
|
||||
|
||||
|
@ -54,7 +54,7 @@ class HighamHall54StepInterpolator
|
|||
* copy: its arrays are separated from the original arrays of the
|
||||
* instance
|
||||
*/
|
||||
public HighamHall54StepInterpolator(final HighamHall54StepInterpolator interpolator) {
|
||||
HighamHall54StepInterpolator(final HighamHall54StepInterpolator interpolator) {
|
||||
super(interpolator);
|
||||
}
|
||||
|
||||
|
|
|
@ -51,7 +51,7 @@ class LutherStepInterpolator extends RungeKuttaStepInterpolator {
|
|||
* to create the step interpolators by cloning an uninitialized model
|
||||
* and later initializing the copy.
|
||||
*/
|
||||
public LutherStepInterpolator() {
|
||||
LutherStepInterpolator() {
|
||||
}
|
||||
|
||||
/** Copy constructor.
|
||||
|
@ -59,7 +59,7 @@ class LutherStepInterpolator extends RungeKuttaStepInterpolator {
|
|||
* copy: its arrays are separated from the original arrays of the
|
||||
* instance
|
||||
*/
|
||||
public LutherStepInterpolator(final LutherStepInterpolator interpolator) {
|
||||
LutherStepInterpolator(final LutherStepInterpolator interpolator) {
|
||||
super(interpolator);
|
||||
}
|
||||
|
||||
|
|
|
@ -61,7 +61,7 @@ class MidpointStepInterpolator
|
|||
* to create the step interpolators by cloning an uninitialized model
|
||||
* and later initializing the copy.
|
||||
*/
|
||||
public MidpointStepInterpolator() {
|
||||
MidpointStepInterpolator() {
|
||||
}
|
||||
|
||||
/** Copy constructor.
|
||||
|
@ -69,7 +69,7 @@ class MidpointStepInterpolator
|
|||
* copy: its arrays are separated from the original arrays of the
|
||||
* instance
|
||||
*/
|
||||
public MidpointStepInterpolator(final MidpointStepInterpolator interpolator) {
|
||||
MidpointStepInterpolator(final MidpointStepInterpolator interpolator) {
|
||||
super(interpolator);
|
||||
}
|
||||
|
||||
|
|
|
@ -79,7 +79,7 @@ abstract class RungeKuttaStepInterpolator
|
|||
* @param interpolator interpolator to copy from.
|
||||
|
||||
*/
|
||||
public RungeKuttaStepInterpolator(final RungeKuttaStepInterpolator interpolator) {
|
||||
RungeKuttaStepInterpolator(final RungeKuttaStepInterpolator interpolator) {
|
||||
|
||||
super(interpolator);
|
||||
|
||||
|
|
|
@ -71,7 +71,7 @@ class ThreeEighthesStepInterpolator
|
|||
* to create the step interpolators by cloning an uninitialized model
|
||||
* and later initializing the copy.
|
||||
*/
|
||||
public ThreeEighthesStepInterpolator() {
|
||||
ThreeEighthesStepInterpolator() {
|
||||
}
|
||||
|
||||
/** Copy constructor.
|
||||
|
@ -79,7 +79,7 @@ class ThreeEighthesStepInterpolator
|
|||
* copy: its arrays are separated from the original arrays of the
|
||||
* instance
|
||||
*/
|
||||
public ThreeEighthesStepInterpolator(final ThreeEighthesStepInterpolator interpolator) {
|
||||
ThreeEighthesStepInterpolator(final ThreeEighthesStepInterpolator interpolator) {
|
||||
super(interpolator);
|
||||
}
|
||||
|
||||
|
|
|
@ -56,7 +56,7 @@ public enum StepNormalizerBounds {
|
|||
* @param last Whether the last point should be passed to the
|
||||
* underlying fixed step size step handler.
|
||||
*/
|
||||
private StepNormalizerBounds(final boolean first, final boolean last) {
|
||||
StepNormalizerBounds(final boolean first, final boolean last) {
|
||||
this.first = first;
|
||||
this.last = last;
|
||||
}
|
||||
|
|
|
@ -107,7 +107,7 @@ public class PointValuePair extends Pair<double[], Double> implements Serializab
|
|||
* @param point Point coordinates.
|
||||
* @param value Value of the objective function at the point.
|
||||
*/
|
||||
public DataTransferObject(final double[] point, final double value) {
|
||||
DataTransferObject(final double[] point, final double value) {
|
||||
this.point = point.clone();
|
||||
this.value = value;
|
||||
}
|
||||
|
|
|
@ -132,7 +132,7 @@ public class PointVectorValuePair extends Pair<double[], double[]> implements Se
|
|||
* @param point Point coordinates.
|
||||
* @param value Value of the objective function at the point.
|
||||
*/
|
||||
public DataTransferObject(final double[] point, final double[] value) {
|
||||
DataTransferObject(final double[] point, final double[] value) {
|
||||
this.point = point.clone();
|
||||
this.value = value.clone();
|
||||
}
|
||||
|
|
|
@ -37,7 +37,7 @@ public enum Relationship {
|
|||
*
|
||||
* @param stringValue Display string for the relationship.
|
||||
*/
|
||||
private Relationship(String stringValue) {
|
||||
Relationship(String stringValue) {
|
||||
this.stringValue = stringValue;
|
||||
}
|
||||
|
||||
|
|
|
@ -224,7 +224,7 @@ public class MultivariateFunctionMappingAdapter
|
|||
*
|
||||
* @param lower lower bound
|
||||
*/
|
||||
public LowerBoundMapper(final double lower) {
|
||||
LowerBoundMapper(final double lower) {
|
||||
this.lower = lower;
|
||||
}
|
||||
|
||||
|
@ -251,7 +251,7 @@ public class MultivariateFunctionMappingAdapter
|
|||
/** Simple constructor.
|
||||
* @param upper upper bound
|
||||
*/
|
||||
public UpperBoundMapper(final double upper) {
|
||||
UpperBoundMapper(final double upper) {
|
||||
this.upper = upper;
|
||||
}
|
||||
|
||||
|
@ -282,7 +282,7 @@ public class MultivariateFunctionMappingAdapter
|
|||
* @param lower lower bound
|
||||
* @param upper upper bound
|
||||
*/
|
||||
public LowerUpperBoundMapper(final double lower, final double upper) {
|
||||
LowerUpperBoundMapper(final double lower, final double upper) {
|
||||
boundingFunction = new Sigmoid(lower, upper);
|
||||
unboundingFunction = new Logit(lower, upper);
|
||||
}
|
||||
|
|
|
@ -69,7 +69,7 @@ public class NonLinearConjugateGradientOptimizer
|
|||
*
|
||||
* @since 2.0
|
||||
*/
|
||||
public static enum Formula {
|
||||
public enum Formula {
|
||||
/** Fletcher-Reeves formula. */
|
||||
FLETCHER_REEVES,
|
||||
/** Polak-Ribière formula. */
|
||||
|
|
|
@ -912,7 +912,7 @@ public class CMAESOptimizer
|
|||
* @param value Function value.
|
||||
* @param penalty Out-of-bounds penalty.
|
||||
*/
|
||||
public ValuePenaltyPair(final double value, final double penalty) {
|
||||
ValuePenaltyPair(final double value, final double penalty) {
|
||||
this.value = value;
|
||||
this.penalty = penalty;
|
||||
}
|
||||
|
@ -932,7 +932,7 @@ public class CMAESOptimizer
|
|||
|
||||
/** Simple constructor.
|
||||
*/
|
||||
public FitnessFunction() {
|
||||
FitnessFunction() {
|
||||
isRepairMode = true;
|
||||
}
|
||||
|
||||
|
|
|
@ -322,7 +322,7 @@ public class EmpiricalDistribution extends AbstractRealDistribution {
|
|||
*
|
||||
* @param in BufferedReader input stream
|
||||
*/
|
||||
public StreamDataAdapter(BufferedReader in){
|
||||
StreamDataAdapter(BufferedReader in){
|
||||
super();
|
||||
inputStream = in;
|
||||
}
|
||||
|
@ -371,7 +371,7 @@ public class EmpiricalDistribution extends AbstractRealDistribution {
|
|||
* @param in double[] array holding the data
|
||||
* @throws NullArgumentException if in is null
|
||||
*/
|
||||
public ArrayDataAdapter(double[] in) throws NullArgumentException {
|
||||
ArrayDataAdapter(double[] in) throws NullArgumentException {
|
||||
super();
|
||||
MathUtils.checkNotNull(in);
|
||||
inputArray = in;
|
||||
|
|
|
@ -56,7 +56,7 @@ class StorelessBivariateCovariance {
|
|||
* Create an empty {@link StorelessBivariateCovariance} instance with
|
||||
* bias correction.
|
||||
*/
|
||||
public StorelessBivariateCovariance() {
|
||||
StorelessBivariateCovariance() {
|
||||
this(true);
|
||||
}
|
||||
|
||||
|
@ -67,7 +67,7 @@ class StorelessBivariateCovariance {
|
|||
* for bias, i.e. n-1 in the denominator, otherwise there is no bias correction,
|
||||
* i.e. n in the denominator.
|
||||
*/
|
||||
public StorelessBivariateCovariance(final boolean biasCorrection) {
|
||||
StorelessBivariateCovariance(final boolean biasCorrection) {
|
||||
meanX = meanY = 0.0;
|
||||
n = 0;
|
||||
covarianceNumerator = 0.0;
|
||||
|
|
|
@ -379,7 +379,7 @@ public class AggregateSummaryStatistics implements StatisticalSummary,
|
|||
* @param aggregateStatistics a {@code SummaryStatistics} into which
|
||||
* values added to this statistics object should be aggregated
|
||||
*/
|
||||
public AggregatingSummaryStatistics(SummaryStatistics aggregateStatistics) {
|
||||
AggregatingSummaryStatistics(SummaryStatistics aggregateStatistics) {
|
||||
this.aggregateStatistics = aggregateStatistics;
|
||||
}
|
||||
|
||||
|
|
|
@ -75,7 +75,7 @@ class FirstMoment extends AbstractStorelessUnivariateStatistic
|
|||
/**
|
||||
* Create a FirstMoment instance
|
||||
*/
|
||||
public FirstMoment() {
|
||||
FirstMoment() {
|
||||
n = 0;
|
||||
m1 = Double.NaN;
|
||||
dev = Double.NaN;
|
||||
|
@ -89,7 +89,7 @@ class FirstMoment extends AbstractStorelessUnivariateStatistic
|
|||
* @param original the {@code FirstMoment} instance to copy
|
||||
* @throws NullArgumentException if original is null
|
||||
*/
|
||||
public FirstMoment(FirstMoment original) throws NullArgumentException {
|
||||
FirstMoment(FirstMoment original) throws NullArgumentException {
|
||||
super();
|
||||
copy(original, this);
|
||||
}
|
||||
|
|
|
@ -64,7 +64,7 @@ class FourthMoment extends ThirdMoment implements Serializable{
|
|||
/**
|
||||
* Create a FourthMoment instance
|
||||
*/
|
||||
public FourthMoment() {
|
||||
FourthMoment() {
|
||||
super();
|
||||
m4 = Double.NaN;
|
||||
}
|
||||
|
@ -76,7 +76,7 @@ class FourthMoment extends ThirdMoment implements Serializable{
|
|||
* @param original the {@code FourthMoment} instance to copy
|
||||
* @throws NullArgumentException if original is null
|
||||
*/
|
||||
public FourthMoment(FourthMoment original) throws NullArgumentException {
|
||||
FourthMoment(FourthMoment original) throws NullArgumentException {
|
||||
super();
|
||||
copy(original, this);
|
||||
}
|
||||
|
|
|
@ -66,7 +66,7 @@ class ThirdMoment extends SecondMoment implements Serializable {
|
|||
/**
|
||||
* Create a FourthMoment instance.
|
||||
*/
|
||||
public ThirdMoment() {
|
||||
ThirdMoment() {
|
||||
super();
|
||||
m3 = Double.NaN;
|
||||
nDevSq = Double.NaN;
|
||||
|
@ -79,7 +79,7 @@ class ThirdMoment extends SecondMoment implements Serializable {
|
|||
* @param original the {@code ThirdMoment} instance to copy
|
||||
* @throws NullArgumentException if original is null
|
||||
*/
|
||||
public ThirdMoment(ThirdMoment original) throws NullArgumentException {
|
||||
ThirdMoment(ThirdMoment original) throws NullArgumentException {
|
||||
copy(original, this);
|
||||
}
|
||||
|
||||
|
|
|
@ -894,7 +894,7 @@ public class PSquarePercentile extends AbstractStorelessUnivariateStatistic
|
|||
*
|
||||
* @param fixedCapacity the capacity to be fixed for this list
|
||||
*/
|
||||
public FixedCapacityList(final int fixedCapacity) {
|
||||
FixedCapacityList(final int fixedCapacity) {
|
||||
super(fixedCapacity);
|
||||
this.capacity = fixedCapacity;
|
||||
}
|
||||
|
|
|
@ -669,7 +669,7 @@ public class Percentile extends AbstractUnivariateStatistic implements Serializa
|
|||
* R-Manual </a></li>
|
||||
* </ol>
|
||||
*/
|
||||
public static enum EstimationType {
|
||||
public enum EstimationType {
|
||||
/**
|
||||
* This is the default type used in the {@link Percentile}.This method
|
||||
* has the following formulae for index and estimates<br>
|
||||
|
@ -928,7 +928,7 @@ public class Percentile extends AbstractUnivariateStatistic implements Serializa
|
|||
*
|
||||
* @param type name of estimation type as per wikipedia
|
||||
*/
|
||||
private EstimationType(final String type) {
|
||||
EstimationType(final String type) {
|
||||
this.name = type;
|
||||
}
|
||||
|
||||
|
|
|
@ -438,7 +438,7 @@ public class NaturalRanking implements RankingAlgorithm {
|
|||
* @param value the value of the pair
|
||||
* @param position the original position
|
||||
*/
|
||||
public IntDoublePair(double value, int position) {
|
||||
IntDoublePair(double value, int position) {
|
||||
this.value = value;
|
||||
this.position = position;
|
||||
}
|
||||
|
|
|
@ -516,8 +516,7 @@ public class FastFourierTransformer implements Serializable {
|
|||
* @param multiDimensionalComplexArray array containing the matrix
|
||||
* elements
|
||||
*/
|
||||
public MultiDimensionalComplexMatrix(
|
||||
Object multiDimensionalComplexArray) {
|
||||
MultiDimensionalComplexMatrix(Object multiDimensionalComplexArray) {
|
||||
|
||||
this.multiDimensionalComplexArray = multiDimensionalComplexArray;
|
||||
|
||||
|
|
|
@ -45,7 +45,7 @@ public class Combinations implements Iterable<int[]> {
|
|||
* Describes the type of iteration performed by the
|
||||
* {@link #iterator() iterator}.
|
||||
*/
|
||||
private static enum IterationOrder {
|
||||
private enum IterationOrder {
|
||||
/** Lexicographic order. */
|
||||
LEXICOGRAPHIC
|
||||
}
|
||||
|
@ -205,7 +205,7 @@ public class Combinations implements Iterable<int[]> {
|
|||
* @param n size of the set from which subsets are enumerated
|
||||
* @param k size of the subsets to enumerate
|
||||
*/
|
||||
public LexicographicIterator(int n, int k) {
|
||||
LexicographicIterator(int n, int k) {
|
||||
this.k = k;
|
||||
c = new int[k + 3];
|
||||
if (k == 0 || k >= n) {
|
||||
|
@ -302,7 +302,7 @@ public class Combinations implements Iterable<int[]> {
|
|||
* Create a singleton iterator providing the given array.
|
||||
* @param singleton array returned by the iterator
|
||||
*/
|
||||
public SingletonIterator(final int[] singleton) {
|
||||
SingletonIterator(final int[] singleton) {
|
||||
this.singleton = singleton;
|
||||
}
|
||||
/** @return True until next is called the first time, then false */
|
||||
|
@ -344,8 +344,7 @@ public class Combinations implements Iterable<int[]> {
|
|||
* @param n Size of the set from which subsets are selected.
|
||||
* @param k Size of the subsets to be enumerated.
|
||||
*/
|
||||
public LexicographicComparator(int n,
|
||||
int k) {
|
||||
LexicographicComparator(int n, int k) {
|
||||
this.n = n;
|
||||
this.k = k;
|
||||
}
|
||||
|
|
|
@ -1655,7 +1655,7 @@ public class FastMath {
|
|||
/** Simple constructor.
|
||||
* @param x number to split
|
||||
*/
|
||||
public Split(final double x) {
|
||||
Split(final double x) {
|
||||
full = x;
|
||||
high = Double.longBitsToDouble(Double.doubleToRawLongBits(x) & ((-1L) << 27));
|
||||
low = x - high;
|
||||
|
@ -1665,7 +1665,7 @@ public class FastMath {
|
|||
* @param high high order bits
|
||||
* @param low low order bits
|
||||
*/
|
||||
public Split(final double high, final double low) {
|
||||
Split(final double high, final double low) {
|
||||
this(high == 0.0 ? (low == 0.0 && Double.doubleToRawLongBits(high) == Long.MIN_VALUE /* negative zero */ ? -0.0 : low) : high + low, high, low);
|
||||
}
|
||||
|
||||
|
@ -1674,7 +1674,7 @@ public class FastMath {
|
|||
* @param high high order bits
|
||||
* @param low low order bits
|
||||
*/
|
||||
public Split(final double full, final double high, final double low) {
|
||||
Split(final double full, final double high, final double low) {
|
||||
this.full = full;
|
||||
this.high = high;
|
||||
this.low = low;
|
||||
|
|
|
@ -312,7 +312,7 @@ public class MathArrays {
|
|||
/**
|
||||
* Specification of ordering direction.
|
||||
*/
|
||||
public static enum OrderDirection {
|
||||
public enum OrderDirection {
|
||||
/** Constant for increasing direction. */
|
||||
INCREASING,
|
||||
/** Constant for decreasing direction. */
|
||||
|
@ -778,7 +778,7 @@ public class MathArrays {
|
|||
* @param key Key.
|
||||
* @param value Value.
|
||||
*/
|
||||
public PairDoubleInteger(double key, int value) {
|
||||
PairDoubleInteger(double key, int value) {
|
||||
this.key = key;
|
||||
this.value = value;
|
||||
}
|
||||
|
@ -1557,7 +1557,7 @@ public class MathArrays {
|
|||
* Specification for indicating that some operation applies
|
||||
* before or after a given index.
|
||||
*/
|
||||
public static enum Position {
|
||||
public enum Position {
|
||||
/** Designates the beginning of the array (near index 0). */
|
||||
HEAD,
|
||||
/** Designates the end of the array. */
|
||||
|
|
|
@ -133,7 +133,7 @@ public class ResizableDoubleArray implements DoubleArray, Serializable {
|
|||
* Specification of expansion algorithm.
|
||||
* @since 3.1
|
||||
*/
|
||||
public static enum ExpansionMode {
|
||||
public enum ExpansionMode {
|
||||
/** Multiplicative expansion mode. */
|
||||
MULTIPLICATIVE,
|
||||
/** Additive expansion mode. */
|
||||
|
|
Loading…
Reference in New Issue