This is an automated email from the ASF dual-hosted git repository.
ggregory pushed a commit to branch master
in repository https://gitbox.apache.org/repos/asf/commons-math.git
The following commit(s) were added to refs/heads/master by this push:
new 087c2eb41 Use HTTPS in URL
087c2eb41 is described below
commit 087c2eb4101da28f39e1c9318de147e44edca82b
Author: Gary Gregory <[email protected]>
AuthorDate: Sun Nov 2 10:36:24 2025 -0500
Use HTTPS in URL
---
.../commons/math4/core/jdkmath/AccurateMath.java | 4 ++--
.../apache/commons/math4/legacy/core/Field.java | 2 +-
.../commons/math4/legacy/core/FieldElement.java | 2 +-
.../commons/math4/legacy/core/MathArrays.java | 2 +-
.../math4/legacy/core/RealFieldElement.java | 4 ++--
.../analysis/differentiation/DSCompiler.java | 2 +-
.../differentiation/DerivativeStructure.java | 2 +-
.../math4/legacy/analysis/function/Gaussian.java | 2 +-
.../analysis/function/HarmonicOscillator.java | 2 +-
.../math4/legacy/analysis/function/Logistic.java | 2 +-
.../math4/legacy/analysis/function/Logit.java | 2 +-
.../math4/legacy/analysis/function/Sigmoid.java | 2 +-
.../math4/legacy/analysis/function/Sinc.java | 2 +-
.../legacy/analysis/function/StepFunction.java | 2 +-
.../IterativeLegendreGaussIntegrator.java | 4 ++--
.../analysis/integration/RombergIntegrator.java | 2 +-
.../analysis/integration/SimpsonIntegrator.java | 2 +-
.../analysis/integration/TrapezoidIntegrator.java | 2 +-
.../integration/gauss/HermiteRuleFactory.java | 4 ++--
.../integration/gauss/LaguerreRuleFactory.java | 2 +-
.../gauss/LegendreHighPrecisionRuleFactory.java | 2 +-
.../integration/gauss/LegendreRuleFactory.java | 2 +-
.../BicubicInterpolatingFunction.java | 2 +-
.../analysis/interpolation/LoessInterpolator.java | 6 ++---
.../MicrosphereProjectionInterpolator.java | 2 +-
.../interpolation/NevilleInterpolator.java | 2 +-
...iecewiseBicubicSplineInterpolatingFunction.java | 2 +-
.../TricubicInterpolatingFunction.java | 2 +-
.../analysis/polynomials/PolynomialFunction.java | 2 +-
.../PolynomialFunctionLagrangeForm.java | 6 ++---
.../polynomials/PolynomialFunctionNewtonForm.java | 2 +-
.../analysis/polynomials/PolynomialsUtils.java | 8 +++----
.../legacy/analysis/solvers/BisectionSolver.java | 2 +-
.../solvers/BracketingNthOrderBrentSolver.java | 2 +-
.../math4/legacy/analysis/solvers/BrentSolver.java | 2 +-
.../FieldBracketingNthOrderBrentSolver.java | 2 +-
.../legacy/analysis/solvers/LaguerreSolver.java | 2 +-
.../legacy/analysis/solvers/MullerSolver.java | 2 +-
.../legacy/analysis/solvers/MullerSolver2.java | 2 +-
.../analysis/solvers/NewtonRaphsonSolver.java | 2 +-
.../legacy/analysis/solvers/RiddersSolver.java | 2 +-
.../distribution/AbstractRealDistribution.java | 2 +-
.../legacy/distribution/EmpiricalDistribution.java | 4 ++--
.../distribution/EnumeratedDistribution.java | 2 +-
.../MixtureMultivariateRealDistribution.java | 2 +-
.../MultivariateNormalDistribution.java | 4 ++--
...ariateNormalMixtureExpectationMaximization.java | 2 +-
.../legacy/field/linalg/FieldLUDecomposition.java | 4 ++--
.../commons/math4/legacy/filter/KalmanFilter.java | 6 ++---
.../leastsquares/LevenbergMarquardtOptimizer.java | 8 +++----
.../math4/legacy/genetics/CycleCrossover.java | 2 +-
.../math4/legacy/genetics/OrderedCrossover.java | 2 +-
.../math4/legacy/genetics/UniformCrossover.java | 6 ++---
.../math4/legacy/linear/CholeskyDecomposition.java | 6 ++---
.../math4/legacy/linear/ConjugateGradient.java | 4 ++--
.../math4/legacy/linear/DecompositionSolver.java | 2 +-
.../math4/legacy/linear/EigenDecomposition.java | 6 ++---
.../math4/legacy/linear/FieldLUDecomposition.java | 6 ++---
.../commons/math4/legacy/linear/FieldMatrix.java | 2 +-
.../math4/legacy/linear/HessenbergTransformer.java | 6 ++---
.../legacy/linear/IterativeLinearSolverEvent.java | 2 +-
.../math4/legacy/linear/LUDecomposition.java | 6 ++---
.../math4/legacy/linear/QRDecomposition.java | 6 ++---
.../math4/legacy/linear/RRQRDecomposition.java | 6 ++---
.../commons/math4/legacy/linear/RealMatrix.java | 6 ++---
.../linear/RectangularCholeskyDecomposition.java | 6 ++---
.../math4/legacy/linear/SchurTransformer.java | 8 +++----
.../legacy/linear/SingularValueDecomposition.java | 6 ++---
.../apache/commons/math4/legacy/linear/SymmLQ.java | 4 ++--
.../legacy/ml/clustering/DBSCANClusterer.java | 4 ++--
.../ml/clustering/KMeansPlusPlusClusterer.java | 2 +-
.../legacy/ml/distance/EarthMoversDistance.java | 2 +-
.../ode/nonstiff/GraggBulirschStoerIntegrator.java | 4 ++--
.../GraggBulirschStoerStepInterpolator.java | 4 ++--
.../legacy/ode/nonstiff/LutherFieldIntegrator.java | 2 +-
.../legacy/ode/nonstiff/LutherIntegrator.java | 2 +-
.../optim/BaseMultiStartMultivariateOptimizer.java | 2 +-
.../nonlinear/scalar/noderiv/BOBYQAOptimizer.java | 4 ++--
.../nonlinear/scalar/noderiv/CMAESOptimizer.java | 8 +++----
.../nonlinear/scalar/noderiv/SimplexOptimizer.java | 2 +-
.../legacy/random/CorrelatedVectorFactory.java | 2 +-
.../legacy/random/HaltonSequenceGenerator.java | 4 ++--
.../legacy/random/SobolSequenceGenerator.java | 8 +++----
.../commons/math4/legacy/special/BesselJ.java | 8 +++----
.../commons/math4/legacy/stat/StatUtils.java | 4 ++--
.../stat/correlation/KendallsCorrelation.java | 4 ++--
.../correlation/StorelessBivariateCovariance.java | 2 +-
.../stat/correlation/StorelessCovariance.java | 2 +-
.../stat/descriptive/DescriptiveStatistics.java | 8 +++----
.../stat/descriptive/StatisticalSummary.java | 2 +-
.../stat/descriptive/rank/PSquarePercentile.java | 6 ++---
.../stat/regression/MultipleLinearRegression.java | 2 +-
.../legacy/stat/regression/RegressionResults.java | 12 +++++-----
.../legacy/stat/regression/SimpleRegression.java | 26 +++++++++++-----------
.../AbstractLeastSquaresOptimizerAbstractTest.java | 6 ++---
.../GaussNewtonOptimizerWithCholeskyTest.java | 6 ++---
.../GaussNewtonOptimizerWithLUTest.java | 6 ++---
.../GaussNewtonOptimizerWithQRTest.java | 6 ++---
.../GaussNewtonOptimizerWithSVDTest.java | 6 ++---
.../LevenbergMarquardtOptimizerTest.java | 6 ++---
.../legacy/fitting/leastsquares/MinpackTest.java | 6 ++---
.../leastsquares/StatisticalReferenceDataset.java | 2 +-
.../NonLinearConjugateGradientOptimizerTest.java | 6 ++---
.../commons/math4/legacy/special/BesselJTest.java | 2 +-
.../math4/neuralnet/SquareNeighbourhood.java | 4 ++--
.../math4/neuralnet/sofm/KohonenUpdateAction.java | 2 +-
.../math4/neuralnet/twod/NeuronSquareMesh2D.java | 2 +-
.../neuralnet/twod/util/UnifiedDistanceMatrix.java | 2 +-
.../math4/transform/FastHadamardTransform.java | 4 ++--
109 files changed, 211 insertions(+), 211 deletions(-)
diff --git
a/commons-math-core/src/main/java/org/apache/commons/math4/core/jdkmath/AccurateMath.java
b/commons-math-core/src/main/java/org/apache/commons/math4/core/jdkmath/AccurateMath.java
index 67c0726e7..f7c6ab773 100644
---
a/commons-math-core/src/main/java/org/apache/commons/math4/core/jdkmath/AccurateMath.java
+++
b/commons-math-core/src/main/java/org/apache/commons/math4/core/jdkmath/AccurateMath.java
@@ -51,7 +51,7 @@ import org.apache.commons.numbers.core.Precision;
* are accurate to about 0.5 ulp throughout the domain range. This statement,
* of course is only a rough global observed behavior, it is <em>not</em> a
* guarantee for <em>every</em> double numbers input (see William Kahan's
- * <a href="http://en.wikipedia.org/wiki/Rounding#The_table-maker.27s_dilemma">
+ * <a
href="https://en.wikipedia.org/wiki/Rounding#The_table-maker.27s_dilemma">
* Table Maker's Dilemma</a>).
* </p>
* <p>
@@ -1413,7 +1413,7 @@ public final class AccurateMath {
}
/**
- * Computes the <a href="http://mathworld.wolfram.com/Logarithm.html">
+ * Computes the <a href="https://mathworld.wolfram.com/Logarithm.html">
* logarithm</a> in a given base.
*
* Returns {@code NaN} if either argument is negative.
diff --git
a/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/Field.java
b/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/Field.java
index 67692cdee..96835dd8a 100644
---
a/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/Field.java
+++
b/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/Field.java
@@ -17,7 +17,7 @@
package org.apache.commons.math4.legacy.core;
/**
- * Interface representing a <a
href="http://mathworld.wolfram.com/Field.html">field</a>.
+ * Interface representing a <a
href="https://mathworld.wolfram.com/Field.html">field</a>.
* <p>
* Classes implementing this interface will often be singletons.
* </p>
diff --git
a/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/FieldElement.java
b/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/FieldElement.java
index a0de70c66..747cd3665 100644
---
a/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/FieldElement.java
+++
b/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/FieldElement.java
@@ -21,7 +21,7 @@ import
org.apache.commons.math4.legacy.exception.NullArgumentException;
/**
- * Interface representing <a
href="http://mathworld.wolfram.com/Field.html">field</a> elements.
+ * Interface representing <a
href="https://mathworld.wolfram.com/Field.html">field</a> elements.
* @param <T> the type of the field elements
* @see Field
* @since 2.0
diff --git
a/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/MathArrays.java
b/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/MathArrays.java
index bb1241c41..7d69aa739 100644
---
a/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/MathArrays.java
+++
b/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/MathArrays.java
@@ -824,7 +824,7 @@ public final class MathArrays {
}
/**
- * Calculates the <a href="http://en.wikipedia.org/wiki/Convolution">
+ * Calculates the <a href="https://en.wikipedia.org/wiki/Convolution">
* convolution</a> between two sequences.
* <p>
* The solution is obtained via straightforward computation of the
diff --git
a/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/RealFieldElement.java
b/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/RealFieldElement.java
index 4383ea57c..854489568 100644
---
a/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/RealFieldElement.java
+++
b/commons-math-legacy-core/src/main/java/org/apache/commons/math4/legacy/core/RealFieldElement.java
@@ -19,8 +19,8 @@ package org.apache.commons.math4.legacy.core;
import org.apache.commons.math4.legacy.exception.DimensionMismatchException;
/**
- * Interface representing a <a
href="http://mathworld.wolfram.com/RealNumber.html">real</a>
- * <a href="http://mathworld.wolfram.com/Field.html">field</a>.
+ * Interface representing a <a
href="https://mathworld.wolfram.com/RealNumber.html">real</a>
+ * <a href="https://mathworld.wolfram.com/Field.html">field</a>.
* @param <T> the type of the field elements
* @see FieldElement
* @since 3.2
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/differentiation/DSCompiler.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/differentiation/DSCompiler.java
index de9ab7690..fe26e9bd6 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/differentiation/DSCompiler.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/differentiation/DSCompiler.java
@@ -32,7 +32,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
/** Class holding "compiled" computation rules for derivative structures.
* <p>This class implements the computation rules described in Dan Kalman's
paper <a
- *
href="http://www1.american.edu/cas/mathstat/People/kalman/pdffiles/mmgautodiff.pdf">Doubly
+ *
href="https://www1.american.edu/cas/mathstat/People/kalman/pdffiles/mmgautodiff.pdf">Doubly
* Recursive Multivariate Automatic Differentiation</a>, Mathematics Magazine,
vol. 75,
* no. 3, June 2002. However, in order to avoid performances bottlenecks, the
recursive
* rules are "compiled" once in an unfold form. This class does this recursion
unrolling
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/differentiation/DerivativeStructure.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/differentiation/DerivativeStructure.java
index 7f5493950..a6033ee49 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/differentiation/DerivativeStructure.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/differentiation/DerivativeStructure.java
@@ -31,7 +31,7 @@ import org.apache.commons.math4.legacy.core.MathArrays;
* <p>This class is the workhorse of the differentiation package.</p>
* <p>This class is an implementation of the extension to Rall's
* numbers described in Dan Kalman's paper <a
- *
href="http://www1.american.edu/cas/mathstat/People/kalman/pdffiles/mmgautodiff.pdf">Doubly
+ *
href="https://www1.american.edu/cas/mathstat/People/kalman/pdffiles/mmgautodiff.pdf">Doubly
* Recursive Multivariate Automatic Differentiation</a>, Mathematics Magazine,
vol. 75,
* no. 3, June 2002. Rall's numbers are an extension to the real numbers used
* throughout mathematical expressions; they hold the derivative together with
the
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Gaussian.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Gaussian.java
index 648bf493b..d0f4faccf 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Gaussian.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Gaussian.java
@@ -29,7 +29,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
import org.apache.commons.numbers.core.Precision;
/**
- * <a href="http://en.wikipedia.org/wiki/Gaussian_function">
+ * <a href="https://en.wikipedia.org/wiki/Gaussian_function">
* Gaussian</a> function.
*
* @since 3.0
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/HarmonicOscillator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/HarmonicOscillator.java
index 11d7a970d..40594360c 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/HarmonicOscillator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/HarmonicOscillator.java
@@ -25,7 +25,7 @@ import
org.apache.commons.math4.legacy.exception.NullArgumentException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * <a href="http://en.wikipedia.org/wiki/Harmonic_oscillator">
+ * <a href="https://en.wikipedia.org/wiki/Harmonic_oscillator">
* simple harmonic oscillator</a> function.
*
* @since 3.0
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Logistic.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Logistic.java
index a0438581c..310467469 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Logistic.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Logistic.java
@@ -26,7 +26,7 @@ import
org.apache.commons.math4.legacy.exception.NullArgumentException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * <a href="http://en.wikipedia.org/wiki/Generalised_logistic_function">
+ * <a href="https://en.wikipedia.org/wiki/Generalised_logistic_function">
* Generalised logistic</a> function.
*
* @since 3.0
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Logit.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Logit.java
index 2f76a5eb5..528f7ecd9 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Logit.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Logit.java
@@ -26,7 +26,7 @@ import
org.apache.commons.math4.legacy.exception.OutOfRangeException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * <a href="http://en.wikipedia.org/wiki/Logit">
+ * <a href="https://en.wikipedia.org/wiki/Logit">
* Logit</a> function.
* It is the inverse of the {@link Sigmoid sigmoid} function.
*
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Sigmoid.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Sigmoid.java
index e007dc4e2..c246a8744 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Sigmoid.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Sigmoid.java
@@ -27,7 +27,7 @@ import
org.apache.commons.math4.legacy.exception.NullArgumentException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * <a href="http://en.wikipedia.org/wiki/Sigmoid_function">
+ * <a href="https://en.wikipedia.org/wiki/Sigmoid_function">
* Sigmoid</a> function.
* It is the inverse of the {@link Logit logit} function.
* A more flexible version, the generalised logistic, is implemented
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Sinc.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Sinc.java
index 4179436aa..eeadc1f2c 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Sinc.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/Sinc.java
@@ -23,7 +23,7 @@ import
org.apache.commons.math4.legacy.exception.DimensionMismatchException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * <a href="http://en.wikipedia.org/wiki/Sinc_function">Sinc</a> function,
+ * <a href="https://en.wikipedia.org/wiki/Sinc_function">Sinc</a> function,
* defined by
* <pre><code>
* sinc(x) = 1 if x = 0,
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/StepFunction.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/StepFunction.java
index d4fb09f6b..86662c3d6 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/StepFunction.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/function/StepFunction.java
@@ -27,7 +27,7 @@ import
org.apache.commons.math4.legacy.exception.NullArgumentException;
import org.apache.commons.math4.legacy.core.MathArrays;
/**
- * <a href="http://en.wikipedia.org/wiki/Step_function">
+ * <a href="https://en.wikipedia.org/wiki/Step_function">
* Step function</a>.
*
* @since 3.0
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/IterativeLegendreGaussIntegrator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/IterativeLegendreGaussIntegrator.java
index 51ee8acd9..889ddc320 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/IterativeLegendreGaussIntegrator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/IterativeLegendreGaussIntegrator.java
@@ -27,7 +27,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
* This algorithm divides the integration interval into equally-sized
* sub-interval and on each of them performs a
- * <a href="http://mathworld.wolfram.com/Legendre-GaussQuadrature.html">
+ * <a href="https://mathworld.wolfram.com/Legendre-GaussQuadrature.html">
* Legendre-Gauss</a> quadrature.
* Because of its <em>non-adaptive</em> nature, this algorithm can
* converge to a wrong value for the integral (for example, if the
@@ -35,7 +35,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* integration interval).
* In particular, a change of variables aimed at estimating integrals
* over infinite intervals as proposed
- * <a
href="http://en.wikipedia.org/w/index.php?title=Numerical_integration#Integrals_over_infinite_intervals">
+ * <a
href="https://en.wikipedia.org/w/index.php?title=Numerical_integration#Integrals_over_infinite_intervals">
* here</a> should be avoided when using this class.
*
* @since 3.1
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/RombergIntegrator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/RombergIntegrator.java
index 73fa19f36..7051a3914 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/RombergIntegrator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/RombergIntegrator.java
@@ -20,7 +20,7 @@ import
org.apache.commons.math4.legacy.exception.NumberIsTooLargeException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * Implements the <a
href="http://mathworld.wolfram.com/RombergIntegration.html">
+ * Implements the <a
href="https://mathworld.wolfram.com/RombergIntegration.html">
* Romberg Algorithm</a> for integration of real univariate functions. For
* reference, see <b>Introduction to Numerical Analysis</b>, ISBN 038795452X,
* chapter 3.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/SimpsonIntegrator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/SimpsonIntegrator.java
index df1fe7273..a07408766 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/SimpsonIntegrator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/SimpsonIntegrator.java
@@ -20,7 +20,7 @@ import
org.apache.commons.math4.legacy.exception.NumberIsTooLargeException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * Implements <a href="http://mathworld.wolfram.com/SimpsonsRule.html">
+ * Implements <a href="https://mathworld.wolfram.com/SimpsonsRule.html">
* Simpson's Rule</a> for integration of real univariate functions.
*
* See <b>Introduction to Numerical Analysis</b>, ISBN 038795452X, chapter 3.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/TrapezoidIntegrator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/TrapezoidIntegrator.java
index 5a8a263b4..abb1d5eb6 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/TrapezoidIntegrator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/TrapezoidIntegrator.java
@@ -20,7 +20,7 @@ import
org.apache.commons.math4.legacy.exception.NumberIsTooLargeException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * Implements the <a href="http://mathworld.wolfram.com/TrapezoidalRule.html">
+ * Implements the <a href="https://mathworld.wolfram.com/TrapezoidalRule.html">
* Trapezoid Rule</a> for integration of real univariate functions.
*
* See <b>Introduction to Numerical Analysis</b>, ISBN 038795452X, chapter 3.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/HermiteRuleFactory.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/HermiteRuleFactory.java
index a5a9491fe..8d3f4904b 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/HermiteRuleFactory.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/HermiteRuleFactory.java
@@ -21,7 +21,7 @@ import org.apache.commons.math4.legacy.core.Pair;
/**
* Factory that creates a
- * <a href="http://en.wikipedia.org/wiki/Gauss-Hermite_quadrature">
+ * <a href="https://en.wikipedia.org/wiki/Gauss-Hermite_quadrature">
* Gauss-type quadrature rule using Hermite polynomials</a>
* of the first kind.
* Such a quadrature rule allows the calculation of improper integrals
@@ -30,7 +30,7 @@ import org.apache.commons.math4.legacy.core.Pair;
* \(f(x) e^{-x^2}\)
* </p><p>
* Recurrence relation and weights computation follow
- * <a href="http://en.wikipedia.org/wiki/Abramowitz_and_Stegun">
+ * <a href="https://en.wikipedia.org/wiki/Abramowitz_and_Stegun">
* Abramowitz and Stegun, 1964</a>.
* </p><p>
* The coefficients of the standard Hermite polynomials grow very rapidly.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LaguerreRuleFactory.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LaguerreRuleFactory.java
index 28f0a1f32..823af29be 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LaguerreRuleFactory.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LaguerreRuleFactory.java
@@ -28,7 +28,7 @@ import org.apache.commons.math4.legacy.core.Pair;
/**
* Factory that creates Gauss-type quadrature rule using Laguerre polynomials.
*
- * @see <a
href="http://en.wikipedia.org/wiki/Gauss%E2%80%93Laguerre_quadrature">Gauss-Laguerre
quadrature (Wikipedia)</a>
+ * @see <a
href="https://en.wikipedia.org/wiki/Gauss%E2%80%93Laguerre_quadrature">Gauss-Laguerre
quadrature (Wikipedia)</a>
* @since 4.0
*/
public class LaguerreRuleFactory extends BaseRuleFactory<Double> {
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LegendreHighPrecisionRuleFactory.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LegendreHighPrecisionRuleFactory.java
index dc636b372..f7b88413f 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LegendreHighPrecisionRuleFactory.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LegendreHighPrecisionRuleFactory.java
@@ -26,7 +26,7 @@ import org.apache.commons.math4.legacy.core.Pair;
* In this implementation, the lower and upper bounds of the natural interval
* of integration are -1 and 1, respectively.
* The Legendre polynomials are evaluated using the recurrence relation
- * presented in <a href="http://en.wikipedia.org/wiki/Abramowitz_and_Stegun">
+ * presented in <a href="https://en.wikipedia.org/wiki/Abramowitz_and_Stegun">
* Abramowitz and Stegun, 1964</a>.
*
* @since 3.1
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LegendreRuleFactory.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LegendreRuleFactory.java
index 347303e40..10595eb2e 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LegendreRuleFactory.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/integration/gauss/LegendreRuleFactory.java
@@ -23,7 +23,7 @@ import org.apache.commons.math4.legacy.core.Pair;
* In this implementation, the lower and upper bounds of the natural interval
* of integration are -1 and 1, respectively.
* The Legendre polynomials are evaluated using the recurrence relation
- * presented in <a href="http://en.wikipedia.org/wiki/Abramowitz_and_Stegun">
+ * presented in <a href="https://en.wikipedia.org/wiki/Abramowitz_and_Stegun">
* Abramowitz and Stegun, 1964</a>.
*
* @since 3.1
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/BicubicInterpolatingFunction.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/BicubicInterpolatingFunction.java
index 84f39f4ed..840f3e843 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/BicubicInterpolatingFunction.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/BicubicInterpolatingFunction.java
@@ -30,7 +30,7 @@ import org.apache.commons.math4.legacy.core.MathArrays;
/**
* Function that implements the
- * <a href="http://en.wikipedia.org/wiki/Bicubic_interpolation">
+ * <a href="https://en.wikipedia.org/wiki/Bicubic_interpolation">
* bicubic spline interpolation</a>.
*
* @since 3.4
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/LoessInterpolator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/LoessInterpolator.java
index b5336651a..ecceb4aba 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/LoessInterpolator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/LoessInterpolator.java
@@ -31,12 +31,12 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
import org.apache.commons.math4.legacy.core.MathArrays;
/**
- * Implements the <a href="http://en.wikipedia.org/wiki/Local_regression">
+ * Implements the <a href="https://en.wikipedia.org/wiki/Local_regression">
* Local Regression Algorithm</a> (also Loess, Lowess) for interpolation of
* real univariate functions.
* <p>
* For reference, see
- * <a
href="http://amstat.tandfonline.com/doi/abs/10.1080/01621459.1979.10481038">
+ * <a
href="https://amstat.tandfonline.com/doi/abs/10.1080/01621459.1979.10481038">
* William S. Cleveland - Robust Locally Weighted Regression and Smoothing
* Scatterplots</a></p>
* <p>
@@ -444,7 +444,7 @@ public class LoessInterpolator
/**
* Compute the
- * <a
href="http://en.wikipedia.org/wiki/Local_regression#Weight_function">tricube</a>
+ * <a
href="https://en.wikipedia.org/wiki/Local_regression#Weight_function">tricube</a>
* weight function.
*
* @param x Argument.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/MicrosphereProjectionInterpolator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/MicrosphereProjectionInterpolator.java
index 85017963e..180bb6e08 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/MicrosphereProjectionInterpolator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/MicrosphereProjectionInterpolator.java
@@ -27,7 +27,7 @@ import
org.apache.commons.math4.legacy.exception.NullArgumentException;
/**
* Interpolator that implements the algorithm described in
* <em>William Dudziak</em>'s
- * <a href="http://rave.ohiolink.edu/etdc/view?acc_num=akron1183403994">MS
thesis</a>.
+ * <a href="https://rave.ohiolink.edu/etdc/view?acc_num=akron1183403994">MS
thesis</a>.
*
* @since 3.6
*/
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/NevilleInterpolator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/NevilleInterpolator.java
index 474ba05c3..ce903741c 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/NevilleInterpolator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/NevilleInterpolator.java
@@ -22,7 +22,7 @@ import
org.apache.commons.math4.legacy.exception.NonMonotonicSequenceException;
import org.apache.commons.math4.legacy.exception.NumberIsTooSmallException;
/**
- * Implements the <a
href="http://mathworld.wolfram.com/NevillesAlgorithm.html">
+ * Implements the <a
href="https://mathworld.wolfram.com/NevillesAlgorithm.html">
* Neville's Algorithm</a> for interpolation of real univariate functions. For
* reference, see <b>Introduction to Numerical Analysis</b>, ISBN 038795452X,
* chapter 2.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/PiecewiseBicubicSplineInterpolatingFunction.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/PiecewiseBicubicSplineInterpolatingFunction.java
index 9a8b80a7a..d17195f07 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/PiecewiseBicubicSplineInterpolatingFunction.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/PiecewiseBicubicSplineInterpolatingFunction.java
@@ -30,7 +30,7 @@ import org.apache.commons.math4.legacy.core.MathArrays;
/**
* Function that implements the
- * <a href="http://www.paulinternet.nl/?page=bicubic">bicubic spline</a>
+ * <a href="https://www.paulinternet.nl/?page=bicubic">bicubic spline</a>
* interpolation.
* This implementation currently uses {@link AkimaSplineInterpolator} as the
* underlying one-dimensional interpolator, which requires 5 sample points;
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/TricubicInterpolatingFunction.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/TricubicInterpolatingFunction.java
index 7e72067d5..f5199da4e 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/TricubicInterpolatingFunction.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/interpolation/TricubicInterpolatingFunction.java
@@ -25,7 +25,7 @@ import org.apache.commons.math4.legacy.core.MathArrays;
/**
* Function that implements the
- * <a href="http://en.wikipedia.org/wiki/Tricubic_interpolation">
+ * <a href="https://en.wikipedia.org/wiki/Tricubic_interpolation">
* tricubic spline interpolation</a>, as proposed in
* <blockquote>
* Tricubic interpolation in three dimensions<br>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunction.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunction.java
index d2bdeea36..c5dc1dd6f 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunction.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunction.java
@@ -29,7 +29,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
* Immutable representation of a real polynomial function with real
coefficients.
* <p>
- * <a href="http://mathworld.wolfram.com/HornersMethod.html">Horner's
Method</a>
+ * <a href="https://mathworld.wolfram.com/HornersMethod.html">Horner's
Method</a>
* is used to evaluate the function.</p>
*
*/
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunctionLagrangeForm.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunctionLagrangeForm.java
index 420a60f19..95ed5e9a0 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunctionLagrangeForm.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunctionLagrangeForm.java
@@ -27,7 +27,7 @@ import org.apache.commons.math4.legacy.core.MathArrays;
/**
* Implements the representation of a real polynomial function in
- * <a href="http://mathworld.wolfram.com/LagrangeInterpolatingPolynomial.html">
+ * <a
href="https://mathworld.wolfram.com/LagrangeInterpolatingPolynomial.html">
* Lagrange Form</a>. For reference, see <b>Introduction to Numerical
* Analysis</b>, ISBN 038795452X, chapter 2.
* <p>
@@ -157,7 +157,7 @@ public class PolynomialFunctionLagrangeForm implements
UnivariateFunction {
/**
* Evaluate the Lagrange polynomial using
- * <a href="http://mathworld.wolfram.com/NevillesAlgorithm.html">
+ * <a href="https://mathworld.wolfram.com/NevillesAlgorithm.html">
* Neville's Algorithm</a>. It takes O(n^2) time.
*
* @param x Interpolating points array.
@@ -191,7 +191,7 @@ public class PolynomialFunctionLagrangeForm implements
UnivariateFunction {
/**
* Evaluate the Lagrange polynomial using
- * <a href="http://mathworld.wolfram.com/NevillesAlgorithm.html">
+ * <a href="https://mathworld.wolfram.com/NevillesAlgorithm.html">
* Neville's Algorithm</a>. It takes O(n^2) time.
*
* @param x Interpolating points array.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunctionNewtonForm.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunctionNewtonForm.java
index 7f00cafbd..b808a6f99 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunctionNewtonForm.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialFunctionNewtonForm.java
@@ -166,7 +166,7 @@ public class PolynomialFunctionNewtonForm implements
UnivariateDifferentiableFun
/**
* Evaluate the Newton polynomial using nested multiplication. It is
- * also called <a href="http://mathworld.wolfram.com/HornersRule.html">
+ * also called <a href="https://mathworld.wolfram.com/HornersRule.html">
* Horner's Rule</a> and takes O(N) time.
*
* @param a Coefficients in Newton form formula.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialsUtils.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialsUtils.java
index 71752436d..3a7c07e44 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialsUtils.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/polynomials/PolynomialsUtils.java
@@ -120,7 +120,7 @@ public final class PolynomialsUtils {
/**
* Create a Hermite polynomial.
- * <p><a href="http://mathworld.wolfram.com/HermitePolynomial.html">Hermite
+ * <p><a
href="https://mathworld.wolfram.com/HermitePolynomial.html">Hermite
* polynomials</a> are orthogonal polynomials.
* They can be defined by the following recurrence relations:</p><p>
* \(
@@ -149,7 +149,7 @@ public final class PolynomialsUtils {
/**
* Create a Laguerre polynomial.
- * <p><a
href="http://mathworld.wolfram.com/LaguerrePolynomial.html">Laguerre
+ * <p><a
href="https://mathworld.wolfram.com/LaguerrePolynomial.html">Laguerre
* polynomials</a> are orthogonal polynomials.
* They can be defined by the following recurrence relations:</p><p>
* \(
@@ -178,7 +178,7 @@ public final class PolynomialsUtils {
/**
* Create a Legendre polynomial.
- * <p><a
href="http://mathworld.wolfram.com/LegendrePolynomial.html">Legendre
+ * <p><a
href="https://mathworld.wolfram.com/LegendrePolynomial.html">Legendre
* polynomials</a> are orthogonal polynomials.
* They can be defined by the following recurrence relations:</p><p>
* \(
@@ -207,7 +207,7 @@ public final class PolynomialsUtils {
/**
* Create a Jacobi polynomial.
- * <p><a href="http://mathworld.wolfram.com/JacobiPolynomial.html">Jacobi
+ * <p><a href="https://mathworld.wolfram.com/JacobiPolynomial.html">Jacobi
* polynomials</a> are orthogonal polynomials.
* They can be defined by the following recurrence relations:</p><p>
* \(
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BisectionSolver.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BisectionSolver.java
index b833b28c9..e5fea2d92 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BisectionSolver.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BisectionSolver.java
@@ -20,7 +20,7 @@ import
org.apache.commons.math4.legacy.exception.TooManyEvaluationsException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * Implements the <a href="http://mathworld.wolfram.com/Bisection.html">
+ * Implements the <a href="https://mathworld.wolfram.com/Bisection.html">
* bisection algorithm</a> for finding zeros of univariate real functions.
* <p>
* The function should be continuous but not necessarily smooth.</p>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BracketingNthOrderBrentSolver.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BracketingNthOrderBrentSolver.java
index 5d8040ec0..3c10fe8f4 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BracketingNthOrderBrentSolver.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BracketingNthOrderBrentSolver.java
@@ -28,7 +28,7 @@ import org.apache.commons.numbers.core.Precision;
/**
* This class implements a modification of the <a
- * href="http://mathworld.wolfram.com/BrentsMethod.html"> Brent algorithm</a>.
+ * href="https://mathworld.wolfram.com/BrentsMethod.html"> Brent algorithm</a>.
* <p>
* The changes with respect to the original Brent algorithm are:
* <ul>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BrentSolver.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BrentSolver.java
index 3e9f209d5..2071db163 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BrentSolver.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/BrentSolver.java
@@ -18,7 +18,7 @@ package org.apache.commons.math4.legacy.analysis.solvers;
/**
- * This class implements the <a
href="http://mathworld.wolfram.com/BrentsMethod.html">
+ * This class implements the <a
href="https://mathworld.wolfram.com/BrentsMethod.html">
* Brent algorithm</a> for finding zeros of real univariate functions.
* The function should be continuous but not necessarily smooth.
* The {@code solve} method returns a zero {@code x} of the function {@code f}
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/FieldBracketingNthOrderBrentSolver.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/FieldBracketingNthOrderBrentSolver.java
index 87f787062..c24bff835 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/FieldBracketingNthOrderBrentSolver.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/FieldBracketingNthOrderBrentSolver.java
@@ -30,7 +30,7 @@ import org.apache.commons.numbers.core.Precision;
/**
* This class implements a modification of the <a
- * href="http://mathworld.wolfram.com/BrentsMethod.html"> Brent algorithm</a>.
+ * href="https://mathworld.wolfram.com/BrentsMethod.html"> Brent algorithm</a>.
* <p>
* The changes with respect to the original Brent algorithm are:
* <ul>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/LaguerreSolver.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/LaguerreSolver.java
index e009473ce..590b8f9d3 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/LaguerreSolver.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/LaguerreSolver.java
@@ -27,7 +27,7 @@ import
org.apache.commons.math4.legacy.exception.util.LocalizedFormats;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * Implements the <a href="http://mathworld.wolfram.com/LaguerresMethod.html">
+ * Implements the <a href="https://mathworld.wolfram.com/LaguerresMethod.html">
* Laguerre's Method</a> for root finding of real coefficient polynomials.
* For reference, see
* <blockquote>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/MullerSolver.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/MullerSolver.java
index f71cdc6bf..79252a2b1 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/MullerSolver.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/MullerSolver.java
@@ -22,7 +22,7 @@ import
org.apache.commons.math4.legacy.exception.TooManyEvaluationsException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * This class implements the <a
href="http://mathworld.wolfram.com/MullersMethod.html">
+ * This class implements the <a
href="https://mathworld.wolfram.com/MullersMethod.html">
* Muller's Method</a> for root finding of real univariate functions. For
* reference, see <b>Elementary Numerical Analysis</b>, ISBN 0070124477,
* chapter 3.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/MullerSolver2.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/MullerSolver2.java
index fd8d3e558..bf12b4f85 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/MullerSolver2.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/MullerSolver2.java
@@ -22,7 +22,7 @@ import
org.apache.commons.math4.legacy.exception.TooManyEvaluationsException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * This class implements the <a
href="http://mathworld.wolfram.com/MullersMethod.html">
+ * This class implements the <a
href="https://mathworld.wolfram.com/MullersMethod.html">
* Muller's Method</a> for root finding of real univariate functions. For
* reference, see <b>Elementary Numerical Analysis</b>, ISBN 0070124477,
* chapter 3.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/NewtonRaphsonSolver.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/NewtonRaphsonSolver.java
index 4b5c5480e..2f9f94c19 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/NewtonRaphsonSolver.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/NewtonRaphsonSolver.java
@@ -23,7 +23,7 @@ import
org.apache.commons.math4.legacy.exception.TooManyEvaluationsException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * Implements <a href="http://mathworld.wolfram.com/NewtonsMethod.html">
+ * Implements <a href="https://mathworld.wolfram.com/NewtonsMethod.html">
* Newton's Method</a> for finding zeros of real univariate differentiable
* functions.
*
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/RiddersSolver.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/RiddersSolver.java
index 4a73eb1dc..074394dd2 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/RiddersSolver.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/analysis/solvers/RiddersSolver.java
@@ -21,7 +21,7 @@ import
org.apache.commons.math4.legacy.exception.TooManyEvaluationsException;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * Implements the <a href="http://mathworld.wolfram.com/RiddersMethod.html">
+ * Implements the <a href="https://mathworld.wolfram.com/RiddersMethod.html">
* Ridders' Method</a> for root finding of real univariate functions. For
* reference, see C. Ridders, <i>A new algorithm for computing a single root
* of a real continuous function </i>, IEEE Transactions on Circuits and
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/AbstractRealDistribution.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/AbstractRealDistribution.java
index 30bfafb39..5411f3067 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/AbstractRealDistribution.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/AbstractRealDistribution.java
@@ -35,7 +35,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* This base class provides a default factory method for creating
* a {@link
org.apache.commons.statistics.distribution.ContinuousDistribution.Sampler
* sampler instance} that uses the
- * <a href="http://en.wikipedia.org/wiki/Inverse_transform_sampling">
+ * <a href="https://en.wikipedia.org/wiki/Inverse_transform_sampling">
* inversion method</a> for generating random samples that follow the
* distribution.
* </p>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/EmpiricalDistribution.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/EmpiricalDistribution.java
index 983d22afd..2c633fe19 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/EmpiricalDistribution.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/EmpiricalDistribution.java
@@ -32,7 +32,7 @@ import
org.apache.commons.math4.legacy.stat.descriptive.SummaryStatistics;
import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
- * <p>Represents an <a
href="http://en.wikipedia.org/wiki/Empirical_distribution_function">
+ * <p>Represents an <a
href="https://en.wikipedia.org/wiki/Empirical_distribution_function">
* empirical probability distribution</a>: Probability distribution derived
* from observed data without making any assumptions about the functional
* form of the population distribution that the data come from.</p>
@@ -55,7 +55,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* the distribution of the values in the file.
*
* <p>The implementation uses what amounts to the
- * <a
href="http://nedwww.ipac.caltech.edu/level5/March02/Silverman/Silver2_6.html">
+ * <a
href="https://nedwww.ipac.caltech.edu/level5/March02/Silverman/Silver2_6.html">
* Variable Kernel Method</a> with Gaussian smoothing:<p>
* <strong>Digesting the input file</strong>
* <ol>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/EnumeratedDistribution.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/EnumeratedDistribution.java
index 9d406dc14..1774ca19c 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/EnumeratedDistribution.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/EnumeratedDistribution.java
@@ -34,7 +34,7 @@ import org.apache.commons.math4.legacy.core.Pair;
/**
* <p>A generic implementation of a
- * <a
href="http://en.wikipedia.org/wiki/Probability_distribution#Discrete_probability_distribution">
+ * <a
href="https://en.wikipedia.org/wiki/Probability_distribution#Discrete_probability_distribution">
* discrete probability distribution (Wikipedia)</a> over a finite sample
space,
* based on an enumerated list of <value, probability> pairs. Input
probabilities must all be non-negative,
* but zero values are allowed and their sum does not have to equal one.
Constructors will normalize input
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/MixtureMultivariateRealDistribution.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/MixtureMultivariateRealDistribution.java
index b8d8929b9..4ca80949d 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/MixtureMultivariateRealDistribution.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/MixtureMultivariateRealDistribution.java
@@ -27,7 +27,7 @@ import org.apache.commons.rng.UniformRandomProvider;
import org.apache.commons.math4.legacy.core.Pair;
/**
- * Class for representing <a href="http://en.wikipedia.org/wiki/Mixture_model">
+ * Class for representing <a
href="https://en.wikipedia.org/wiki/Mixture_model">
* mixture model</a> distributions.
*
* @param <T> Type of the mixture components.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/MultivariateNormalDistribution.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/MultivariateNormalDistribution.java
index 8470f9541..85523adf0 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/MultivariateNormalDistribution.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/MultivariateNormalDistribution.java
@@ -31,9 +31,9 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
* Implementation of the multivariate normal (Gaussian) distribution.
*
- * @see <a
href="http://en.wikipedia.org/wiki/Multivariate_normal_distribution">
+ * @see <a
href="https://en.wikipedia.org/wiki/Multivariate_normal_distribution">
* Multivariate normal distribution (Wikipedia)</a>
- * @see <a
href="http://mathworld.wolfram.com/MultivariateNormalDistribution.html">
+ * @see <a
href="https://mathworld.wolfram.com/MultivariateNormalDistribution.html">
* Multivariate normal distribution (MathWorld)</a>
*
* @since 3.1
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/fitting/MultivariateNormalMixtureExpectationMaximization.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/fitting/MultivariateNormalMixtureExpectationMaximization.java
index a3c7397d2..35920338e 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/fitting/MultivariateNormalMixtureExpectationMaximization.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/distribution/fitting/MultivariateNormalMixtureExpectationMaximization.java
@@ -45,7 +45,7 @@ import org.apache.commons.math4.legacy.core.Pair;
* EM Demystified: An Expectation-Maximization Tutorial</a> by Yihua Chen and
Maya R. Gupta,
* Department of Electrical Engineering, University of Washington, Seattle, WA
98195.
* It was verified using external tools like <a
- * href="http://cran.r-project.org/web/packages/mixtools/index.html">CRAN
Mixtools</a>
+ * href="https://cran.r-project.org/web/packages/mixtools/index.html">CRAN
Mixtools</a>
* (see the JUnit test cases) but it is <strong>not</strong> based on Mixtools
code at all.
* The discussion of the origin of this class can be seen in the comments of
the <a
* href="https://issues.apache.org/jira/browse/MATH-817">MATH-817</a> JIRA
issue.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/field/linalg/FieldLUDecomposition.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/field/linalg/FieldLUDecomposition.java
index 0bfd700c0..3505a0ad3 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/field/linalg/FieldLUDecomposition.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/field/linalg/FieldLUDecomposition.java
@@ -35,8 +35,8 @@ import
org.apache.commons.math4.legacy.linear.SingularMatrixException;
*
* @param <T> Type of the field elements.
*
- * @see <a
href="http://mathworld.wolfram.com/LUDecomposition.html">MathWorld</a>
- * @see <a href="http://en.wikipedia.org/wiki/LU_decomposition">Wikipedia</a>
+ * @see <a
href="https://mathworld.wolfram.com/LUDecomposition.html">MathWorld</a>
+ * @see <a href="https://en.wikipedia.org/wiki/LU_decomposition">Wikipedia</a>
*
* @since 4.0
*/
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/filter/KalmanFilter.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/filter/KalmanFilter.java
index 5e6f93ecd..7afc238c7 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/filter/KalmanFilter.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/filter/KalmanFilter.java
@@ -68,11 +68,11 @@ import
org.apache.commons.math4.legacy.linear.SingularMatrixException;
* <li>P - error covariance matrix</li>
* </ul>
*
- * @see <a href="http://www.cs.unc.edu/~welch/kalman/">Kalman filter
+ * @see <a href="https://www.cs.unc.edu/~welch/kalman/">Kalman filter
* resources</a>
- * @see <a href="http://www.cs.unc.edu/~welch/media/pdf/kalman_intro.pdf">An
+ * @see <a href="https://www.cs.unc.edu/~welch/media/pdf/kalman_intro.pdf">An
* introduction to the Kalman filter by Greg Welch and Gary Bishop</a>
- * @see <a href="http://academic.csuohio.edu/simond/courses/eec644/kalman.pdf">
+ * @see <a
href="https://academic.csuohio.edu/simond/courses/eec644/kalman.pdf">
* Kalman filter example by Dan Simon</a>
* @see ProcessModel
* @see MeasurementModel
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/fitting/leastsquares/LevenbergMarquardtOptimizer.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/fitting/leastsquares/LevenbergMarquardtOptimizer.java
index c7ffea1ab..2c09f8f95 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/fitting/leastsquares/LevenbergMarquardtOptimizer.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/fitting/leastsquares/LevenbergMarquardtOptimizer.java
@@ -40,7 +40,7 @@ import org.apache.commons.numbers.core.Precision;
* are changed to implement this.</p>
*
* <p>The resolution engine is a simple translation of the MINPACK <a
- * href="http://www.netlib.org/minpack/lmder.f">lmder</a> routine with minor
+ * href="https://www.netlib.org/minpack/lmder.f">lmder</a> routine with minor
* changes. The changes include the over-determined resolution, the use of
* inherited convergence checker and the Q.R. decomposition which has been
* rewritten following the algorithm described in the
@@ -54,7 +54,7 @@ import org.apache.commons.numbers.core.Precision;
* <li>Jorge J. More</li>
* </ul>
* The redistribution policy for MINPACK is available <a
- * href="http://www.netlib.org/minpack/disclaimer">here</a>, for convenience,
it
+ * href="https://www.netlib.org/minpack/disclaimer">here</a>, for convenience,
it
* is reproduced below.
*
* <table style="text-align: center; background-color: #E0E0E0" border="">
@@ -593,7 +593,7 @@ public class LevenbergMarquardtOptimizer implements
LeastSquaresOptimizer {
* Determines the Levenberg-Marquardt parameter.
*
* <p>This implementation is a translation in Java of the MINPACK
- * <a href="http://www.netlib.org/minpack/lmpar.f">lmpar</a>
+ * <a href="https://www.netlib.org/minpack/lmpar.f">lmpar</a>
* routine.</p>
* <p>This method sets the lmPar and lmDir attributes.</p>
* <p>The authors of the original fortran function are:</p>
@@ -779,7 +779,7 @@ public class LevenbergMarquardtOptimizer implements
LeastSquaresOptimizer {
/**
* Solve a*x = b and d*x = 0 in the least squares sense.
* <p>This implementation is a translation in Java of the MINPACK
- * <a href="http://www.netlib.org/minpack/qrsolv.f">qrsolv</a>
+ * <a href="https://www.netlib.org/minpack/qrsolv.f">qrsolv</a>
* routine.</p>
* <p>This method sets the lmDir and lmDiag attributes.</p>
* <p>The authors of the original fortran function are:</p>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/CycleCrossover.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/CycleCrossover.java
index 5f06354c0..e70b13b6e 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/CycleCrossover.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/CycleCrossover.java
@@ -55,7 +55,7 @@ import
org.apache.commons.math4.legacy.exception.util.LocalizedFormats;
* This policy works only on {@link AbstractListChromosome}, and therefore it
* is parameterized by T. Moreover, the chromosomes must have same lengths.
*
- * @see <a
href="http://www.rubicite.com/Tutorials/GeneticAlgorithms/CrossoverOperators/CycleCrossoverOperator.aspx">
+ * @see <a
href="https://www.rubicite.com/Tutorials/GeneticAlgorithms/CrossoverOperators/CycleCrossoverOperator.aspx">
* Cycle Crossover Operator</a>
*
* @param <T> generic type of the {@link AbstractListChromosome}s for crossover
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/OrderedCrossover.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/OrderedCrossover.java
index 7669b55ba..594e64e4b 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/OrderedCrossover.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/OrderedCrossover.java
@@ -51,7 +51,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* This policy works only on {@link AbstractListChromosome}, and therefore it
* is parameterized by T. Moreover, the chromosomes must have same lengths.
*
- * @see <a
href="http://www.rubicite.com/Tutorials/GeneticAlgorithms/CrossoverOperators/Order1CrossoverOperator.aspx">
+ * @see <a
href="https://www.rubicite.com/Tutorials/GeneticAlgorithms/CrossoverOperators/Order1CrossoverOperator.aspx">
* Order 1 Crossover Operator</a>
*
* @param <T> generic type of the {@link AbstractListChromosome}s for crossover
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/UniformCrossover.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/UniformCrossover.java
index e1bd43a23..e4ea8b791 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/UniformCrossover.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/genetics/UniformCrossover.java
@@ -42,9 +42,9 @@ import org.apache.commons.rng.UniformRandomProvider;
* This policy works only on {@link AbstractListChromosome}, and therefore it
* is parameterized by T. Moreover, the chromosomes must have same lengths.
*
- * @see <a
href="http://en.wikipedia.org/wiki/Crossover_%28genetic_algorithm%29">Crossover
techniques (Wikipedia)</a>
- * @see <a
href="http://www.obitko.com/tutorials/genetic-algorithms/crossover-mutation.php">Crossover
(Obitko.com)</a>
- * @see <a href="http://www.tomaszgwiazda.com/uniformX.htm">Uniform
crossover</a>
+ * @see <a
href="https://en.wikipedia.org/wiki/Crossover_%28genetic_algorithm%29">Crossover
techniques (Wikipedia)</a>
+ * @see <a
href="https://www.obitko.com/tutorials/genetic-algorithms/crossover-mutation.php">Crossover
(Obitko.com)</a>
+ * @see <a href="https://www.tomaszgwiazda.com/uniformX.htm">Uniform
crossover</a>
* @param <T> generic type of the {@link AbstractListChromosome}s for crossover
* @since 3.1
*/
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/CholeskyDecomposition.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/CholeskyDecomposition.java
index ef54331bf..2e8a5a073 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/CholeskyDecomposition.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/CholeskyDecomposition.java
@@ -27,7 +27,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* matrix A consists of a lower triangular matrix L with same size such
* that: A = LL<sup>T</sup>. In a sense, this is the square root of A.</p>
* <p>This class is based on the class with similar name from the
- * <a href="http://math.nist.gov/javanumerics/jama/">JAMA</a> library, with the
+ * <a href="https://math.nist.gov/javanumerics/jama/">JAMA</a> library, with
the
* following changes:</p>
* <ul>
* <li>a {@link #getLT() getLT} method has been added,</li>
@@ -40,8 +40,8 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* {@link DecompositionSolver}.</li>
* </ul>
*
- * @see <a
href="http://mathworld.wolfram.com/CholeskyDecomposition.html">MathWorld</a>
- * @see <a
href="http://en.wikipedia.org/wiki/Cholesky_decomposition">Wikipedia</a>
+ * @see <a
href="https://mathworld.wolfram.com/CholeskyDecomposition.html">MathWorld</a>
+ * @see <a
href="https://en.wikipedia.org/wiki/Cholesky_decomposition">Wikipedia</a>
* @since 2.0 (changed to concrete class in 3.0)
*/
public class CholeskyDecomposition {
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/ConjugateGradient.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/ConjugateGradient.java
index 42479bf85..fbd21c3d2 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/ConjugateGradient.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/ConjugateGradient.java
@@ -60,12 +60,12 @@ import
org.apache.commons.math4.legacy.exception.util.ExceptionContext;
* <dt><a id="BARR1994">Barret et al. (1994)</a></dt>
* <dd>R. Barrett, M. Berry, T. F. Chan, J. Demmel, J. M. Donato, J. Dongarra,
* V. Eijkhout, R. Pozo, C. Romine and H. Van der Vorst,
- * <a href="http://www.netlib.org/linalg/html_templates/Templates.html"><em>
+ * <a href="https://www.netlib.org/linalg/html_templates/Templates.html"><em>
* Templates for the Solution of Linear Systems: Building Blocks for Iterative
* Methods</em></a>, SIAM</dd>
* <dt><a id="STRA2002">Strakos and Tichy (2002)</a></dt>
* <dd>Z. Strakos and P. Tichy, <a
- * href="http://etna.mcs.kent.edu/vol.13.2002/pp56-80.dir/pp56-80.pdf">
+ * href="https://etna.mcs.kent.edu/vol.13.2002/pp56-80.dir/pp56-80.pdf">
* <em>On error estimation in the conjugate gradient method and why it works
* in finite precision computations</em></a>, Electronic Transactions on
* Numerical Analysis 13: 56-80, 2002</dd>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/DecompositionSolver.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/DecompositionSolver.java
index a23cda747..81aeae313 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/DecompositionSolver.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/DecompositionSolver.java
@@ -69,7 +69,7 @@ public interface DecompositionSolver {
boolean isNonSingular();
/**
- * Get the <a
href="http://en.wikipedia.org/wiki/Moore%E2%80%93Penrose_pseudoinverse">pseudo-inverse</a>
+ * Get the <a
href="https://en.wikipedia.org/wiki/Moore%E2%80%93Penrose_pseudoinverse">pseudo-inverse</a>
* of the decomposed matrix.
* <p>
* <em>This is equal to the inverse of the decomposed matrix, if such an
inverse exists.</em>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/EigenDecomposition.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/EigenDecomposition.java
index c3295e4c5..8a2b87bd7 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/EigenDecomposition.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/EigenDecomposition.java
@@ -34,7 +34,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* A, V and D are all m × m matrices.
* <p>
* This class is similar in spirit to the {@code EigenvalueDecomposition}
- * class from the <a href="http://math.nist.gov/javanumerics/jama/">JAMA</a>
+ * class from the <a href="https://math.nist.gov/javanumerics/jama/">JAMA</a>
* library, with the following changes:
* <ul>
* <li>a {@link #getVT() getVt} method has been added,</li>
@@ -72,8 +72,8 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* Handbook for automatic computation, vol. 2, Linear algebra, Springer-Verlag,
* New-York.
*
- * @see <a
href="http://mathworld.wolfram.com/EigenDecomposition.html">MathWorld</a>
- * @see <a
href="http://en.wikipedia.org/wiki/Eigendecomposition_of_a_matrix">Wikipedia</a>
+ * @see <a
href="https://mathworld.wolfram.com/EigenDecomposition.html">MathWorld</a>
+ * @see <a
href="https://en.wikipedia.org/wiki/Eigendecomposition_of_a_matrix">Wikipedia</a>
* @since 2.0 (changed to concrete class in 3.0)
*/
public class EigenDecomposition {
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/FieldLUDecomposition.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/FieldLUDecomposition.java
index a93dd6b9e..e0b0cadde 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/FieldLUDecomposition.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/FieldLUDecomposition.java
@@ -33,7 +33,7 @@ import org.apache.commons.math4.legacy.core.MathArrays;
* a zero pivot element, no attempt is done to get the largest pivot
* element.</p>
* <p>This class is based on the class with similar name from the
- * <a href="http://math.nist.gov/javanumerics/jama/">JAMA</a> library.</p>
+ * <a href="https://math.nist.gov/javanumerics/jama/">JAMA</a> library.</p>
* <ul>
* <li>a {@link #getP() getP} method has been added,</li>
* <li>the {@code det} method has been renamed as {@link #getDeterminant()
@@ -46,8 +46,8 @@ import org.apache.commons.math4.legacy.core.MathArrays;
* </ul>
*
* @param <T> the type of the field elements
- * @see <a
href="http://mathworld.wolfram.com/LUDecomposition.html">MathWorld</a>
- * @see <a href="http://en.wikipedia.org/wiki/LU_decomposition">Wikipedia</a>
+ * @see <a
href="https://mathworld.wolfram.com/LUDecomposition.html">MathWorld</a>
+ * @see <a href="https://en.wikipedia.org/wiki/LU_decomposition">Wikipedia</a>
* @since 2.0 (changed to concrete class in 3.0)
*/
public class FieldLUDecomposition<T extends FieldElement<T>> {
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/FieldMatrix.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/FieldMatrix.java
index 3bb739cc0..b703fbde7 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/FieldMatrix.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/FieldMatrix.java
@@ -448,7 +448,7 @@ public interface FieldMatrix<T extends FieldElement<T>>
extends AnyMatrix {
FieldMatrix<T> transpose();
/**
- * Returns the <a href="http://mathworld.wolfram.com/MatrixTrace.html">
+ * Returns the <a href="https://mathworld.wolfram.com/MatrixTrace.html">
* trace</a> of the matrix (the sum of the elements on the main diagonal).
*
* @return trace
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/HessenbergTransformer.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/HessenbergTransformer.java
index 1474cfc40..14823d7a8 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/HessenbergTransformer.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/HessenbergTransformer.java
@@ -32,10 +32,10 @@ import org.apache.commons.numbers.core.Precision;
* of this explicitly limited scope, many methods directly returns references
to
* internal arrays, not copies.</p>
* <p>This class is based on the method orthes in class EigenvalueDecomposition
- * from the <a href="http://math.nist.gov/javanumerics/jama/">JAMA</a>
library.</p>
+ * from the <a href="https://math.nist.gov/javanumerics/jama/">JAMA</a>
library.</p>
*
- * @see <a
href="http://mathworld.wolfram.com/HessenbergDecomposition.html">MathWorld</a>
- * @see <a
href="http://en.wikipedia.org/wiki/Householder_transformation">Householder
Transformations</a>
+ * @see <a
href="https://mathworld.wolfram.com/HessenbergDecomposition.html">MathWorld</a>
+ * @see <a
href="https://en.wikipedia.org/wiki/Householder_transformation">Householder
Transformations</a>
* @since 3.1
*/
class HessenbergTransformer {
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/IterativeLinearSolverEvent.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/IterativeLinearSolverEvent.java
index 12a16ad91..acaa7bc55 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/IterativeLinearSolverEvent.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/IterativeLinearSolverEvent.java
@@ -62,7 +62,7 @@ public abstract class IterativeLinearSolverEvent
* Z. Strakos, <em>Predicting the Behavior of Finite Precision Lanzos and
* Conjugate Gradient Computations</em>, Technical Report 538, Department
of
* Computer Science, New York University, 1991 (available
- * <a
href="http://www.archive.org/details/predictingbehavi00gree">here</a>).
+ * <a
href="https://www.archive.org/details/predictingbehavi00gree">here</a>).
*
* @return the norm of the residual, ||r||
*/
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/LUDecomposition.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/LUDecomposition.java
index b2360462f..51e008f82 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/LUDecomposition.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/LUDecomposition.java
@@ -29,7 +29,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* <p>As shown by the presence of the P matrix, this decomposition is
* implemented using partial pivoting.</p>
* <p>This class is based on the class with similar name from the
- * <a href="http://math.nist.gov/javanumerics/jama/">JAMA</a> library.</p>
+ * <a href="https://math.nist.gov/javanumerics/jama/">JAMA</a> library.</p>
* <ul>
* <li>a {@link #getP() getP} method has been added,</li>
* <li>the {@code det} method has been renamed as {@link #getDeterminant()
@@ -41,8 +41,8 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* provided by the returned {@link DecompositionSolver}.</li>
* </ul>
*
- * @see <a
href="http://mathworld.wolfram.com/LUDecomposition.html">MathWorld</a>
- * @see <a href="http://en.wikipedia.org/wiki/LU_decomposition">Wikipedia</a>
+ * @see <a
href="https://mathworld.wolfram.com/LUDecomposition.html">MathWorld</a>
+ * @see <a href="https://en.wikipedia.org/wiki/LU_decomposition">Wikipedia</a>
* @since 2.0 (changed to concrete class in 3.0)
*/
public class LUDecomposition {
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/QRDecomposition.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/QRDecomposition.java
index bfa49f3f6..c9b1920f8 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/QRDecomposition.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/QRDecomposition.java
@@ -34,7 +34,7 @@ import
org.apache.commons.math4.legacy.exception.util.LocalizedFormats;
* This allows inner loop to iterate inside rows, which is much more
cache-efficient
* in Java.</p>
* <p>This class is based on the class with similar name from the
- * <a href="http://math.nist.gov/javanumerics/jama/">JAMA</a> library, with the
+ * <a href="https://math.nist.gov/javanumerics/jama/">JAMA</a> library, with
the
* following changes:</p>
* <ul>
* <li>a {@link #getQT() getQT} method has been added,</li>
@@ -43,8 +43,8 @@ import
org.apache.commons.math4.legacy.exception.util.LocalizedFormats;
* provided by the returned {@link DecompositionSolver}.</li>
* </ul>
*
- * @see <a
href="http://mathworld.wolfram.com/QRDecomposition.html">MathWorld</a>
- * @see <a href="http://en.wikipedia.org/wiki/QR_decomposition">Wikipedia</a>
+ * @see <a
href="https://mathworld.wolfram.com/QRDecomposition.html">MathWorld</a>
+ * @see <a href="https://en.wikipedia.org/wiki/QR_decomposition">Wikipedia</a>
*
* @since 1.2 (changed to concrete class in 3.0)
*/
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RRQRDecomposition.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RRQRDecomposition.java
index 9988f8ffe..a17c35979 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RRQRDecomposition.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RRQRDecomposition.java
@@ -33,7 +33,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* This allows inner loop to iterate inside rows, which is much more
cache-efficient
* in Java.</p>
* <p>This class is based on the class with similar name from the
- * <a href="http://math.nist.gov/javanumerics/jama/">JAMA</a> library, with the
+ * <a href="https://math.nist.gov/javanumerics/jama/">JAMA</a> library, with
the
* following changes:</p>
* <ul>
* <li>a {@link #getQT() getQT} method has been added,</li>
@@ -42,8 +42,8 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* provided by the returned {@link DecompositionSolver}.</li>
* </ul>
*
- * @see <a
href="http://mathworld.wolfram.com/QRDecomposition.html">MathWorld</a>
- * @see <a href="http://en.wikipedia.org/wiki/QR_decomposition">Wikipedia</a>
+ * @see <a
href="https://mathworld.wolfram.com/QRDecomposition.html">MathWorld</a>
+ * @see <a href="https://en.wikipedia.org/wiki/QR_decomposition">Wikipedia</a>
*
* @since 3.2
*/
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RealMatrix.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RealMatrix.java
index dc74f27a1..6e13f9628 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RealMatrix.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RealMatrix.java
@@ -138,7 +138,7 @@ public interface RealMatrix extends AnyMatrix {
double[][] getData();
/**
- * Returns the <a
href="http://mathworld.wolfram.com/MaximumAbsoluteRowSumNorm.html">
+ * Returns the <a
href="https://mathworld.wolfram.com/MaximumAbsoluteRowSumNorm.html">
* maximum absolute row sum norm</a> of the matrix.
*
* @return norm
@@ -146,7 +146,7 @@ public interface RealMatrix extends AnyMatrix {
double getNorm();
/**
- * Returns the <a href="http://mathworld.wolfram.com/FrobeniusNorm.html">
+ * Returns the <a href="https://mathworld.wolfram.com/FrobeniusNorm.html">
* Frobenius norm</a> of the matrix.
*
* @return norm
@@ -464,7 +464,7 @@ public interface RealMatrix extends AnyMatrix {
RealMatrix transpose();
/**
- * Returns the <a href="http://mathworld.wolfram.com/MatrixTrace.html">
+ * Returns the <a href="https://mathworld.wolfram.com/MatrixTrace.html">
* trace</a> of the matrix (the sum of the elements on the main diagonal).
*
* @return the trace.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RectangularCholeskyDecomposition.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RectangularCholeskyDecomposition.java
index b66f214c3..dac5a4fc7 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RectangularCholeskyDecomposition.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/RectangularCholeskyDecomposition.java
@@ -37,8 +37,8 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* linear systems, so it does not provide any {@link DecompositionSolver
* decomposition solver}.</p>
*
- * @see <a
href="http://mathworld.wolfram.com/CholeskyDecomposition.html">MathWorld</a>
- * @see <a
href="http://en.wikipedia.org/wiki/Cholesky_decomposition">Wikipedia</a>
+ * @see <a
href="https://mathworld.wolfram.com/CholeskyDecomposition.html">MathWorld</a>
+ * @see <a
href="https://en.wikipedia.org/wiki/Cholesky_decomposition">Wikipedia</a>
* @since 2.0 (changed to concrete class in 3.0)
*/
public class RectangularCholeskyDecomposition {
@@ -56,7 +56,7 @@ public class RectangularCholeskyDecomposition {
* columns by proceeding with the Cholesky algorithm until a nonpositive
diagonal
* element is encountered.
*
- * @see <a
href="http://eprints.ma.man.ac.uk/1193/01/covered/MIMS_ep2008_56.pdf">
+ * @see <a
href="https://eprints.ma.man.ac.uk/1193/01/covered/MIMS_ep2008_56.pdf">
* Analysis of the Cholesky Decomposition of a Semi-definite Matrix</a>
*
* @param matrix Symmetric positive semidefinite matrix.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SchurTransformer.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SchurTransformer.java
index 7edc27fd4..25373baff 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SchurTransformer.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SchurTransformer.java
@@ -34,11 +34,11 @@ import org.apache.commons.numbers.core.Precision;
* of this explicitly limited scope, many methods directly returns references
to
* internal arrays, not copies.</p>
* <p>This class is based on the method hqr2 in class EigenvalueDecomposition
- * from the <a href="http://math.nist.gov/javanumerics/jama/">JAMA</a>
library.</p>
+ * from the <a href="https://math.nist.gov/javanumerics/jama/">JAMA</a>
library.</p>
*
- * @see <a href="http://mathworld.wolfram.com/SchurDecomposition.html">Schur
Decomposition - MathWorld</a>
- * @see <a href="http://en.wikipedia.org/wiki/Schur_decomposition">Schur
Decomposition - Wikipedia</a>
- * @see <a
href="http://en.wikipedia.org/wiki/Householder_transformation">Householder
Transformations</a>
+ * @see <a href="https://mathworld.wolfram.com/SchurDecomposition.html">Schur
Decomposition - MathWorld</a>
+ * @see <a href="https://en.wikipedia.org/wiki/Schur_decomposition">Schur
Decomposition - Wikipedia</a>
+ * @see <a
href="https://en.wikipedia.org/wiki/Householder_transformation">Householder
Transformations</a>
* @since 3.1
*/
class SchurTransformer {
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SingularValueDecomposition.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SingularValueDecomposition.java
index 76bc1044c..6f0476c01 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SingularValueDecomposition.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SingularValueDecomposition.java
@@ -32,7 +32,7 @@ import org.apache.commons.numbers.core.Precision;
* p=min(m,n).
* </p>
* <p>This class is similar to the class with similar name from the
- * <a href="http://math.nist.gov/javanumerics/jama/">JAMA</a> library, with the
+ * <a href="https://math.nist.gov/javanumerics/jama/">JAMA</a> library, with
the
* following changes:</p>
* <ul>
* <li>the {@code norm2} method which has been renamed as {@link #getNorm()
@@ -46,8 +46,8 @@ import org.apache.commons.numbers.core.Precision;
* <li>a {@link #getSolver() getSolver} method has been added,</li>
* <li>a {@link #getCovariance(double) getCovariance} method has been
added.</li>
* </ul>
- * @see <a
href="http://mathworld.wolfram.com/SingularValueDecomposition.html">MathWorld</a>
- * @see <a
href="http://en.wikipedia.org/wiki/Singular_value_decomposition">Wikipedia</a>
+ * @see <a
href="https://mathworld.wolfram.com/SingularValueDecomposition.html">MathWorld</a>
+ * @see <a
href="https://en.wikipedia.org/wiki/Singular_value_decomposition">Wikipedia</a>
* @since 2.0 (changed to concrete class in 3.0)
*/
public class SingularValueDecomposition {
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SymmLQ.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SymmLQ.java
index f02fb84f6..ec422c82e 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SymmLQ.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/linear/SymmLQ.java
@@ -27,7 +27,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* Implementation of the SYMMLQ iterative linear solver proposed by <a
* href="#PAIG1975">Paige and Saunders (1975)</a>. This implementation is
* largely based on the FORTRAN code by Pr. Michael A. Saunders, available <a
- * href="http://www.stanford.edu/group/SOL/software/symmlq/f77/">here</a>.
+ * href="https://www.stanford.edu/group/SOL/software/symmlq/f77/">here</a>.
* </p>
* <p>
* SYMMLQ is designed to solve the system of linear equations A · x = b
@@ -141,7 +141,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* <dl>
* <dt><a id="PAIG1975">Paige and Saunders (1975)</a></dt>
* <dd>C. C. Paige and M. A. Saunders, <a
- * href="http://www.stanford.edu/group/SOL/software/symmlq/PS75.pdf"><em>
+ * href="https://www.stanford.edu/group/SOL/software/symmlq/PS75.pdf"><em>
* Solution of Sparse Indefinite Systems of Linear Equations</em></a>, SIAM
* Journal on Numerical Analysis 12(4): 617-629, 1975</dd>
* </dl>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/clustering/DBSCANClusterer.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/clustering/DBSCANClusterer.java
index 0687b6ed5..f732a9d77 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/clustering/DBSCANClusterer.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/clustering/DBSCANClusterer.java
@@ -50,8 +50,8 @@ import
org.apache.commons.math4.legacy.ml.distance.EuclideanDistance;
* </ul>
*
* @param <T> type of the points to cluster
- * @see <a href="http://en.wikipedia.org/wiki/DBSCAN">DBSCAN (wikipedia)</a>
- * @see <a
href="http://www.dbs.ifi.lmu.de/Publikationen/Papers/KDD-96.final.frame.pdf">
+ * @see <a href="https://en.wikipedia.org/wiki/DBSCAN">DBSCAN (wikipedia)</a>
+ * @see <a
href="https://www.dbs.ifi.lmu.de/Publikationen/Papers/KDD-96.final.frame.pdf">
* A Density-Based Algorithm for Discovering Clusters in Large Spatial
Databases with Noise</a>
* @since 3.2
*/
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/clustering/KMeansPlusPlusClusterer.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/clustering/KMeansPlusPlusClusterer.java
index ebb533d4b..99c614b3b 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/clustering/KMeansPlusPlusClusterer.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/clustering/KMeansPlusPlusClusterer.java
@@ -35,7 +35,7 @@ import java.util.List;
/**
* Clustering algorithm based on David Arthur and Sergei Vassilvitski
k-means++ algorithm.
* @param <T> type of the points to cluster
- * @see <a href="http://en.wikipedia.org/wiki/K-means%2B%2B">K-means++
(wikipedia)</a>
+ * @see <a href="https://en.wikipedia.org/wiki/K-means%2B%2B">K-means++
(wikipedia)</a>
* @since 3.2
*/
public class KMeansPlusPlusClusterer<T extends Clusterable> extends
Clusterer<T> {
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/distance/EarthMoversDistance.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/distance/EarthMoversDistance.java
index 6963d8228..d47d1bf90 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/distance/EarthMoversDistance.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ml/distance/EarthMoversDistance.java
@@ -22,7 +22,7 @@ import org.apache.commons.math4.legacy.core.MathArrays;
/**
* Calculates the Earth Mover's distance (also known as Wasserstein metric)
between two distributions.
*
- * @see <a href="http://en.wikipedia.org/wiki/Earth_mover's_distance">Earth
Mover's distance (Wikipedia)</a>
+ * @see <a href="https://en.wikipedia.org/wiki/Earth_mover's_distance">Earth
Mover's distance (Wikipedia)</a>
*
* @since 3.3
*/
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/GraggBulirschStoerIntegrator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/GraggBulirschStoerIntegrator.java
index 56ec113e4..a7da9a987 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/GraggBulirschStoerIntegrator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/GraggBulirschStoerIntegrator.java
@@ -56,10 +56,10 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* <p>
* This implementation is basically a reimplementation in Java of the
* <a
- * href="http://www.unige.ch/math/folks/hairer/prog/nonstiff/odex.f">odex</a>
+ * href="https://www.unige.ch/math/folks/hairer/prog/nonstiff/odex.f">odex</a>
* fortran code by E. Hairer and G. Wanner. The redistribution policy
* for this code is available <a
- * href="http://www.unige.ch/~hairer/prog/licence.txt">here</a>, for
+ * href="https://www.unige.ch/~hairer/prog/licence.txt">here</a>, for
* convenience, it is reproduced below.</p>
*
* <table border="" style="text-align: center; background-color: #E0E0E0">
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/GraggBulirschStoerStepInterpolator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/GraggBulirschStoerStepInterpolator.java
index 83ec8e512..8d55fd33f 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/GraggBulirschStoerStepInterpolator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/GraggBulirschStoerStepInterpolator.java
@@ -36,10 +36,10 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* <p>
* This implementation is basically a reimplementation in Java of the
* <a
- * href="http://www.unige.ch/math/folks/hairer/prog/nonstiff/odex.f">odex</a>
+ * href="https://www.unige.ch/math/folks/hairer/prog/nonstiff/odex.f">odex</a>
* fortran code by E. Hairer and G. Wanner. The redistribution policy
* for this code is available <a
- * href="http://www.unige.ch/~hairer/prog/licence.txt">here</a>, for
+ * href="https://www.unige.ch/~hairer/prog/licence.txt">here</a>, for
* convenience, it is reproduced below.</p>
*
* <table border="" style="text-align: center; background-color: #E0E0E0;">
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/LutherFieldIntegrator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/LutherFieldIntegrator.java
index 1cbef0387..bb96b1974 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/LutherFieldIntegrator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/LutherFieldIntegrator.java
@@ -30,7 +30,7 @@ import org.apache.commons.math4.legacy.core.MathArrays;
* <p>
* This method is described in H. A. Luther 1968 paper <a
- *
href="http://www.ams.org/journals/mcom/1968-22-102/S0025-5718-68-99876-1/S0025-5718-68-99876-1.pdf">
+ *
href="https://www.ams.org/journals/mcom/1968-22-102/S0025-5718-68-99876-1/S0025-5718-68-99876-1.pdf">
* An explicit Sixth-Order Runge-Kutta Formula</a>.
* </p>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/LutherIntegrator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/LutherIntegrator.java
index 13f55b35d..e7f7d71b1 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/LutherIntegrator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/ode/nonstiff/LutherIntegrator.java
@@ -26,7 +26,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* <p>
* This method is described in H. A. Luther 1968 paper <a
- *
href="http://www.ams.org/journals/mcom/1968-22-102/S0025-5718-68-99876-1/S0025-5718-68-99876-1.pdf">
+ *
href="https://www.ams.org/journals/mcom/1968-22-102/S0025-5718-68-99876-1/S0025-5718-68-99876-1.pdf">
* An explicit Sixth-Order Runge-Kutta Formula</a>.
* </p>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/BaseMultiStartMultivariateOptimizer.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/BaseMultiStartMultivariateOptimizer.java
index f4e57f3e6..28182d2b4 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/BaseMultiStartMultivariateOptimizer.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/BaseMultiStartMultivariateOptimizer.java
@@ -66,7 +66,7 @@ public abstract class
BaseMultiStartMultivariateOptimizer<PAIR>
* a good probability to generate vectors in the bounded domain, otherwise
the
* rejection algorithm will hit the {@link #getMaxEvaluations()} count
without
* generating a proper restart point. Users must be take great care of the
<a
- * href="http://en.wikipedia.org/wiki/Curse_of_dimensionality">curse of
dimensionality</a>.
+ * href="https://en.wikipedia.org/wiki/Curse_of_dimensionality">curse of
dimensionality</a>.
* </p>
* @param optimizer Single-start optimizer to wrap.
* @param starts Number of starts to perform. If {@code starts == 1},
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/BOBYQAOptimizer.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/BOBYQAOptimizer.java
index 5842dfceb..16921985c 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/BOBYQAOptimizer.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/BOBYQAOptimizer.java
@@ -33,8 +33,8 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
/**
* Powell's BOBYQA algorithm. This implementation is translated and
* adapted from the Fortran version available
- * <a href="http://plato.asu.edu/ftp/other_software/bobyqa.zip">here</a>.
- * See <a href="http://www.optimization-online.org/DB_HTML/2010/05/2616.html">
+ * <a href="https://plato.asu.edu/ftp/other_software/bobyqa.zip">here</a>.
+ * See <a href="https://www.optimization-online.org/DB_HTML/2010/05/2616.html">
* this paper</a> for an introduction.
* <br>
* BOBYQA is particularly well suited for high dimensional problems
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/CMAESOptimizer.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/CMAESOptimizer.java
index 28c1d0f41..4c570b7cd 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/CMAESOptimizer.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/CMAESOptimizer.java
@@ -74,9 +74,9 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* <p>
* For more information, please refer to the following links:
* <ul>
- * <li><a href="http://www.lri.fr/~hansen/cmaes.m">Matlab code</a></li>
- * <li><a href="http://www.lri.fr/~hansen/cmaesintro.html">Introduction to
CMA-ES</a></li>
- * <li><a href="http://en.wikipedia.org/wiki/CMA-ES">Wikipedia</a></li>
+ * <li><a href="https://www.lri.fr/~hansen/cmaes.m">Matlab code</a></li>
+ * <li><a href="https://www.lri.fr/~hansen/cmaesintro.html">Introduction to
CMA-ES</a></li>
+ * <li><a href="https://en.wikipedia.org/wiki/CMA-ES">Wikipedia</a></li>
* </ul>
*
* @since 3.0
@@ -117,7 +117,7 @@ public class CMAESOptimizer
* diagonalOnly = 1 means keeping the covariance matrix always diagonal and
* this setting also exhibits linear space complexity. This can be
* particularly useful for dimension > 100.
- * @see <a href="http://hal.archives-ouvertes.fr/inria-00287367/en">A
Simple Modification in CMA-ES</a>
+ * @see <a href="https://hal.archives-ouvertes.fr/inria-00287367/en">A
Simple Modification in CMA-ES</a>
*/
private int diagonalOnly;
/** Number of objective variables/problem dimension. */
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/SimplexOptimizer.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/SimplexOptimizer.java
index 1916ab625..a8b76a04b 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/SimplexOptimizer.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/noderiv/SimplexOptimizer.java
@@ -50,7 +50,7 @@ import
org.apache.commons.math4.legacy.optim.nonlinear.scalar.ObjectiveFunction;
* Direct search methods only use objective function values, they do
* not need derivatives and don't either try to compute approximation
* of the derivatives. According to a 1996 paper by Margaret H. Wright
- * (<a href="http://cm.bell-labs.com/cm/cs/doc/96/4-02.ps.gz">Direct
+ * (<a href="https://cm.bell-labs.com/cm/cs/doc/96/4-02.ps.gz">Direct
* Search Methods: Once Scorned, Now Respectable</a>), they are used
* when either the computation of the derivative is impossible (noisy
* functions, unpredictable discontinuities) or difficult (complexity,
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/CorrelatedVectorFactory.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/CorrelatedVectorFactory.java
index 9b681d7d4..1e37a765f 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/CorrelatedVectorFactory.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/CorrelatedVectorFactory.java
@@ -40,7 +40,7 @@ import
org.apache.commons.math4.legacy.linear.RectangularCholeskyDecomposition;
* simulation of physical problems with several variables (for example to
* generate error vectors to be added to a nominal vector). A particularly
* common case is when the generated vector should be drawn from a
- * <a href="http://en.wikipedia.org/wiki/Multivariate_normal_distribution">
+ * <a href="https://en.wikipedia.org/wiki/Multivariate_normal_distribution">
* Multivariate Normal Distribution</a>, usually using Cholesky decomposition.
* Other distributions are possible as long as the underlying sampler provides
* normalized values (unit standard deviation).</p>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/HaltonSequenceGenerator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/HaltonSequenceGenerator.java
index a45e16e93..27337a3f5 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/HaltonSequenceGenerator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/HaltonSequenceGenerator.java
@@ -38,7 +38,7 @@ import
org.apache.commons.math4.legacy.exception.OutOfRangeException;
* <p>
* Halton sequences are known to suffer from linear correlation for larger
prime numbers, thus the individual digits
* are usually scrambled. This implementation already comes with support for
up to 40 dimensions with optimal weight
- * numbers from <a
href="http://etd.lib.fsu.edu/theses/available/etd-07062004-140409/unrestricted/dissertation1.pdf">
+ * numbers from <a
href="https://etd.lib.fsu.edu/theses/available/etd-07062004-140409/unrestricted/dissertation1.pdf">
* H. Chi: Scrambled quasirandom sequences and their applications</a>.
* <p>
* The generator supports two modes:
@@ -47,7 +47,7 @@ import
org.apache.commons.math4.legacy.exception.OutOfRangeException;
* <li>random access to the i-th point in the sequence: {@link
#skipTo(int)}</li>
* </ul>
*
- * @see <a href="http://en.wikipedia.org/wiki/Halton_sequence">Halton sequence
(Wikipedia)</a>
+ * @see <a href="https://en.wikipedia.org/wiki/Halton_sequence">Halton
sequence (Wikipedia)</a>
* @see <a
href="https://lirias.kuleuven.be/bitstream/123456789/131168/1/mcm2005_bartv.pdf">
* On the Halton sequence and its scramblings</a>
* @since 3.3
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/SobolSequenceGenerator.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/SobolSequenceGenerator.java
index dcf1ad102..bf4a2a9ac 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/SobolSequenceGenerator.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/random/SobolSequenceGenerator.java
@@ -40,7 +40,7 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* points in a space S, which are equi-distributed.
* <p>
* The implementation already comes with support for up to 21201 dimensions
with direction numbers
- * calculated from <a href="http://web.maths.unsw.edu.au/~fkuo/sobol/">Stephen
Joe and Frances Kuo</a>.
+ * calculated from <a
href="https://web.maths.unsw.edu.au/~fkuo/sobol/">Stephen Joe and Frances
Kuo</a>.
* <p>
* The generator supports two modes:
* <ul>
@@ -48,8 +48,8 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* <li>random access to the i-th point in the sequence: {@link
#skipTo(int)}</li>
* </ul>
*
- * @see <a href="http://en.wikipedia.org/wiki/Sobol_sequence">Sobol sequence
(Wikipedia)</a>
- * @see <a href="http://web.maths.unsw.edu.au/~fkuo/sobol/">Sobol sequence
direction numbers</a>
+ * @see <a href="https://en.wikipedia.org/wiki/Sobol_sequence">Sobol sequence
(Wikipedia)</a>
+ * @see <a href="https://web.maths.unsw.edu.au/~fkuo/sobol/">Sobol sequence
direction numbers</a>
*
* @since 3.3
*/
@@ -126,7 +126,7 @@ public class SobolSequenceGenerator implements
Supplier<double[]> {
* direction vectors loaded from the given stream.
* <p>
* The expected format is identical to the files available from
- * <a href="http://web.maths.unsw.edu.au/~fkuo/sobol/">Stephen Joe and
Frances Kuo</a>.
+ * <a href="https://web.maths.unsw.edu.au/~fkuo/sobol/">Stephen Joe and
Frances Kuo</a>.
* The first line will be ignored as it is assumed to contain only the
column headers.
* The columns are:
* <ul>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/special/BesselJ.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/special/BesselJ.java
index 05906c082..6ad328ff4 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/special/BesselJ.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/special/BesselJ.java
@@ -29,12 +29,12 @@ import org.apache.commons.math4.core.jdkmath.JdkMath;
* This class provides computation methods related to Bessel
* functions of the first kind. Detailed descriptions of these functions are
* available in <a
- * href="http://en.wikipedia.org/wiki/Bessel_function">Wikipedia</a>, <a
- * href="http://en.wikipedia.org/wiki/Abramowitz_and_Stegun">Abrabowitz and
- * Stegun</a> (Ch. 9-11), and <a href="http://dlmf.nist.gov/">DLMF</a> (Ch.
10).
+ * href="https://en.wikipedia.org/wiki/Bessel_function">Wikipedia</a>, <a
+ * href="https://en.wikipedia.org/wiki/Abramowitz_and_Stegun">Abrabowitz and
+ * Stegun</a> (Ch. 9-11), and <a href="https://dlmf.nist.gov/">DLMF</a> (Ch.
10).
* <p>
* This implementation is based on the rjbesl Fortran routine at
- * <a href="http://www.netlib.org/specfun/rjbesl">Netlib</a>.</p>
+ * <a href="https://www.netlib.org/specfun/rjbesl">Netlib</a>.</p>
* <p>
* From the Fortran code: </p>
* <p>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/StatUtils.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/StatUtils.java
index 13531977e..841c46564 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/StatUtils.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/StatUtils.java
@@ -338,7 +338,7 @@ public final class StatUtils {
}
/**
- * Returns the <a
href="http://en.wikibooks.org/wiki/Statistics/Summary/Variance">
+ * Returns the <a
href="https://en.wikibooks.org/wiki/Statistics/Summary/Variance">
* population variance</a> of the entries in the input array, or
* <code>Double.NaN</code> if the array is empty.
* <p>
@@ -359,7 +359,7 @@ public final class StatUtils {
}
/**
- * Returns the <a
href="http://en.wikibooks.org/wiki/Statistics/Summary/Variance">
+ * Returns the <a
href="https://en.wikibooks.org/wiki/Statistics/Summary/Variance">
* population variance</a> of the entries in the specified portion of
* the input array, or <code>Double.NaN</code> if the designated subarray
* is empty.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/KendallsCorrelation.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/KendallsCorrelation.java
index 0f2dfb8a6..862949336 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/KendallsCorrelation.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/KendallsCorrelation.java
@@ -60,9 +60,9 @@ import org.apache.commons.math4.legacy.core.Pair;
* Kendall's Tau with Ungrouped Data" in the Journal of the American
* Statistical Association.
*
- * @see <a
href="http://en.wikipedia.org/wiki/Kendall_tau_rank_correlation_coefficient">
+ * @see <a
href="https://en.wikipedia.org/wiki/Kendall_tau_rank_correlation_coefficient">
* Kendall tau rank correlation coefficient (Wikipedia)</a>
- * @see <a href="http://www.jstor.org/stable/2282833">A Computer
+ * @see <a href="https://www.jstor.org/stable/2282833">A Computer
* Method for Calculating Kendall's Tau with Ungrouped Data</a>
*
* @since 3.3
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/StorelessBivariateCovariance.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/StorelessBivariateCovariance.java
index 83a010bfa..48892aaf6 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/StorelessBivariateCovariance.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/StorelessBivariateCovariance.java
@@ -24,7 +24,7 @@ import
org.apache.commons.math4.legacy.exception.util.LocalizedFormats;
* stored in memory.
*
* <p>This class is based on a paper written by Philippe Pébay:
- * <a href="http://prod.sandia.gov/techlib/access-control.cgi/2008/086212.pdf">
+ * <a
href="https://prod.sandia.gov/techlib/access-control.cgi/2008/086212.pdf">
* Formulas for Robust, One-Pass Parallel Computation of Covariances and
* Arbitrary-Order Statistical Moments</a>, 2008, Technical Report
SAND2008-6212,
* Sandia National Laboratories. It computes the covariance for a pair of
variables.
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/StorelessCovariance.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/StorelessCovariance.java
index 035ad804e..fc2fec6f1 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/StorelessCovariance.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/correlation/StorelessCovariance.java
@@ -29,7 +29,7 @@ import org.apache.commons.math4.legacy.linear.RealMatrix;
* calls to incrementRow() or increment Covariance().
*
* <p>This class is based on a paper written by Philippe Pébay:
- * <a href="http://prod.sandia.gov/techlib/access-control.cgi/2008/086212.pdf">
+ * <a
href="https://prod.sandia.gov/techlib/access-control.cgi/2008/086212.pdf">
* Formulas for Robust, One-Pass Parallel Computation of Covariances and
* Arbitrary-Order Statistical Moments</a>, 2008, Technical Report
SAND2008-6212,
* Sandia National Laboratories.</p>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/DescriptiveStatistics.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/DescriptiveStatistics.java
index 36ba82bcc..518488495 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/DescriptiveStatistics.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/DescriptiveStatistics.java
@@ -210,7 +210,7 @@ public class DescriptiveStatistics implements
StatisticalSummary {
}
/**
- * Returns the <a href="http://www.xycoon.com/arithmetic_mean.htm">
+ * Returns the <a href="https://www.xycoon.com/arithmetic_mean.htm">
* arithmetic mean </a> of the available values.
* @return The mean or Double.NaN if no values have been added.
*/
@@ -220,7 +220,7 @@ public class DescriptiveStatistics implements
StatisticalSummary {
}
/**
- * Returns the <a href="http://www.xycoon.com/geometric_mean.htm">
+ * Returns the <a href="https://www.xycoon.com/geometric_mean.htm">
* geometric mean </a> of the available values.
* <p>
* See {@link GeometricMean} for details on the computing algorithm.</p>
@@ -266,7 +266,7 @@ public class DescriptiveStatistics implements
StatisticalSummary {
/**
* Returns the quadratic mean, a.k.a.
- * <a href="http://mathworld.wolfram.com/Root-Mean-Square.html">
+ * <a href="https://mathworld.wolfram.com/Root-Mean-Square.html">
* root-mean-square</a> of the available values
* @return The quadratic mean or {@code Double.NaN} if no values
* have been added.
@@ -429,7 +429,7 @@ public class DescriptiveStatistics implements
StatisticalSummary {
* Returns an estimate for the pth percentile of the stored values.
* <p>
* The implementation provided here follows the first estimation procedure
presented
- * <a
href="http://www.itl.nist.gov/div898/handbook/prc/section2/prc252.htm">here.</a>
+ * <a
href="https://www.itl.nist.gov/div898/handbook/prc/section2/prc252.htm">here.</a>
* </p><p>
* <strong>Preconditions</strong>:<ul>
* <li><code>0 < p ≤ 100</code> (otherwise an
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/StatisticalSummary.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/StatisticalSummary.java
index 931d5d03e..389a67097 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/StatisticalSummary.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/StatisticalSummary.java
@@ -23,7 +23,7 @@ package org.apache.commons.math4.legacy.stat.descriptive;
public interface StatisticalSummary {
/**
- * Returns the <a href="http://www.xycoon.com/arithmetic_mean.htm">
+ * Returns the <a href="https://www.xycoon.com/arithmetic_mean.htm">
* arithmetic mean </a> of the available values.
* @return The mean or Double.NaN if no values have been added.
*/
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/rank/PSquarePercentile.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/rank/PSquarePercentile.java
index dd234aa07..e64e0f667 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/rank/PSquarePercentile.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/descriptive/rank/PSquarePercentile.java
@@ -37,10 +37,10 @@ import
org.apache.commons.math4.legacy.stat.descriptive.StorelessUnivariateStati
/**
* A {@link StorelessUnivariateStatistic} estimating percentiles using the
- * <a
href="http://www.cs.wustl.edu/~jain/papers/ftp/psqr.pdf">P<SUP>2</SUP></a>
- * Algorithm as explained by <a href="http://www.cse.wustl.edu/~jain/">Raj
+ * <a
href="https://www.cs.wustl.edu/~jain/papers/ftp/psqr.pdf">P<SUP>2</SUP></a>
+ * Algorithm as explained by <a href="https://www.cse.wustl.edu/~jain/">Raj
* Jain</a> and Imrich Chlamtac in
- * <a href="http://www.cse.wustl.edu/~jain/papers/psqr.htm">P<SUP>2</SUP>
Algorithm
+ * <a href="https://www.cse.wustl.edu/~jain/papers/psqr.htm">P<SUP>2</SUP>
Algorithm
* for Dynamic Calculation of Quantiles and Histogram Without Storing
* Observations</a>.
* <p>
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/MultipleLinearRegression.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/MultipleLinearRegression.java
index 2b3f802a0..cfd7c7ba1 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/MultipleLinearRegression.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/MultipleLinearRegression.java
@@ -26,7 +26,7 @@ package org.apache.commons.math4.legacy.stat.regression;
* of <b>error terms</b> or <b>residuals</b>.
*
* The notation is quite standard in literature,
- * cf eg <a href="http://www.econ.queensu.ca/ETM">Davidson and MacKinnon,
Econometrics Theory and Methods, 2004</a>.
+ * cf eg <a href="https://www.econ.queensu.ca/ETM">Davidson and MacKinnon,
Econometrics Theory and Methods, 2004</a>.
* @since 2.0
*/
public interface MultipleLinearRegression {
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/RegressionResults.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/RegressionResults.java
index 67cea8d57..2f0de5e78 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/RegressionResults.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/RegressionResults.java
@@ -173,7 +173,7 @@ public class RegressionResults {
}
/**
- * Returns the <a href="http://www.xycoon.com/standerrorb(1).htm">standard
+ * Returns the <a href="https://www.xycoon.com/standerrorb(1).htm">standard
* error of the parameter estimate at index</a>,
* usually denoted s(b<sub>index</sub>).
*
@@ -197,7 +197,7 @@ public class RegressionResults {
}
/**
- * <p>Returns the <a
href="http://www.xycoon.com/standerrorb(1).htm">standard
+ * <p>Returns the <a
href="https://www.xycoon.com/standerrorb(1).htm">standard
* error of the parameter estimates</a>,
* usually denoted s(b<sub>i</sub>).</p>
*
@@ -276,7 +276,7 @@ public class RegressionResults {
* <p>Returns the sum of squared deviations of the y values about their
mean.</p>
*
* <p>This is defined as SSTO
- * <a href="http://www.xycoon.com/SumOfSquares.htm">here</a>.</p>
+ * <a href="https://www.xycoon.com/SumOfSquares.htm">here</a>.</p>
*
* <p>If {@code n < 2}, this returns {@code Double.NaN}.</p>
*
@@ -291,7 +291,7 @@ public class RegressionResults {
* their mean (which equals the mean of y).</p>
*
* <p>This is usually abbreviated SSR or SSM. It is defined as SSM
- * <a href="http://www.xycoon.com/SumOfSquares.htm">here</a></p>
+ * <a href="https://www.xycoon.com/SumOfSquares.htm">here</a></p>
*
* <p><strong>Preconditions</strong>: <ul>
* <li>At least two observations (with at least two different x values)
@@ -307,7 +307,7 @@ public class RegressionResults {
}
/**
- * <p>Returns the <a href="http://www.xycoon.com/SumOfSquares.htm">
+ * <p>Returns the <a href="https://www.xycoon.com/SumOfSquares.htm">
* sum of squared errors</a> (SSE) associated with the regression
* model.</p>
*
@@ -343,7 +343,7 @@ public class RegressionResults {
}
/**
- * <p>Returns the <a href="http://www.xycoon.com/coefficient1.htm">
+ * <p>Returns the <a href="https://www.xycoon.com/coefficient1.htm">
* coefficient of multiple determination</a>,
* usually denoted r-square.</p>
*
diff --git
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/SimpleRegression.java
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/SimpleRegression.java
index 44d73219c..83aef56be 100644
---
a/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/SimpleRegression.java
+++
b/commons-math-legacy/src/main/java/org/apache/commons/math4/legacy/stat/regression/SimpleRegression.java
@@ -156,7 +156,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
* <p>The mean update formulae are based on a paper written by Philippe
* Pébay:
* <a
- *
href="http://prod.sandia.gov/techlib/access-control.cgi/2008/086212.pdf">
+ *
href="https://prod.sandia.gov/techlib/access-control.cgi/2008/086212.pdf">
* Formulas for Robust, One-Pass Parallel Computation of Covariances and
* Arbitrary-Order Statistical Moments</a>, 2008, Technical Report
* SAND2008-6212, Sandia National Laboratories.</p>
@@ -384,7 +384,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
* {@link #hasIntercept()} is true; otherwise 0.
* <p>
* The least squares estimate of the intercept is computed using the
- * <a href="http://www.xycoon.com/estimation4.htm">normal equations</a>.
+ * <a href="https://www.xycoon.com/estimation4.htm">normal equations</a>.
* The intercept is sometimes denoted b0.</p>
* <p>
* <strong>Preconditions</strong>: <ul>
@@ -417,7 +417,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
* Returns the slope of the estimated regression line.
* <p>
* The least squares estimate of the slope is computed using the
- * <a href="http://www.xycoon.com/estimation4.htm">normal equations</a>.
+ * <a href="https://www.xycoon.com/estimation4.htm">normal equations</a>.
* The slope is sometimes denoted b1.</p>
* <p>
* <strong>Preconditions</strong>: <ul>
@@ -440,7 +440,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
}
/**
- * Returns the <a href="http://www.xycoon.com/SumOfSquares.htm">
+ * Returns the <a href="https://www.xycoon.com/SumOfSquares.htm">
* sum of squared errors</a> (SSE) associated with the regression
* model.
* <p>
@@ -476,7 +476,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
* Returns the sum of squared deviations of the y values about their mean.
* <p>
* This is defined as SSTO
- * <a href="http://www.xycoon.com/SumOfSquares.htm">here</a>.</p>
+ * <a href="https://www.xycoon.com/SumOfSquares.htm">here</a>.</p>
* <p>
* If {@code n < 2}, this returns <code>Double.NaN</code>.</p>
*
@@ -517,7 +517,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
* their mean (which equals the mean of y).
* <p>
* This is usually abbreviated SSR or SSM. It is defined as SSM
- * <a href="http://www.xycoon.com/SumOfSquares.htm">here</a></p>
+ * <a href="https://www.xycoon.com/SumOfSquares.htm">here</a></p>
* <p>
* <strong>Preconditions</strong>: <ul>
* <li>At least two observations (with at least two different x values)
@@ -550,7 +550,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
}
/**
- * Returns <a
href="http://mathworld.wolfram.com/CorrelationCoefficient.html">
+ * Returns <a
href="https://mathworld.wolfram.com/CorrelationCoefficient.html">
* Pearson's product moment correlation coefficient</a>,
* usually denoted r.
* <p>
@@ -573,7 +573,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
}
/**
- * Returns the <a href="http://www.xycoon.com/coefficient1.htm">
+ * Returns the <a href="https://www.xycoon.com/coefficient1.htm">
* coefficient of determination</a>,
* usually denoted r-square.
* <p>
@@ -592,7 +592,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
}
/**
- * Returns the <a href="http://www.xycoon.com/standarderrorb0.htm">
+ * Returns the <a href="https://www.xycoon.com/standarderrorb0.htm">
* standard error of the intercept estimate</a>,
* usually denoted s(b0).
* <p>
@@ -612,7 +612,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
}
/**
- * Returns the <a href="http://www.xycoon.com/standerrorb(1).htm">standard
+ * Returns the <a href="https://www.xycoon.com/standerrorb(1).htm">standard
* error of the slope estimate</a>,
* usually denoted s(b1).
* <p>
@@ -642,7 +642,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
* <strong>Usage Note</strong>:<br>
* The validity of this statistic depends on the assumption that the
* observations included in the model are drawn from a
- * <a href="http://mathworld.wolfram.com/BivariateNormalDistribution.html">
+ * <a
href="https://mathworld.wolfram.com/BivariateNormalDistribution.html">
* Bivariate Normal Distribution</a>.</p>
*
* @return half-width of 95% confidence interval for the slope estimate
@@ -667,7 +667,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
* <strong>Usage Note</strong>:<br>
* The validity of this statistic depends on the assumption that the
* observations included in the model are drawn from a
- * <a href="http://mathworld.wolfram.com/BivariateNormalDistribution.html">
+ * <a
href="https://mathworld.wolfram.com/BivariateNormalDistribution.html">
* Bivariate Normal Distribution</a>.</p>
* <p>
* <strong> Preconditions:</strong><ul>
@@ -709,7 +709,7 @@ public class SimpleRegression implements
UpdatingMultipleLinearRegression {
* <strong>Usage Note</strong>:<br>
* The validity of this statistic depends on the assumption that the
* observations included in the model are drawn from a
- * <a href="http://mathworld.wolfram.com/BivariateNormalDistribution.html">
+ * <a
href="https://mathworld.wolfram.com/BivariateNormalDistribution.html">
* Bivariate Normal Distribution</a>.</p>
* <p>
* If there are fewer that <strong>three</strong> observations in the
diff --git
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/AbstractLeastSquaresOptimizerAbstractTest.java
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/AbstractLeastSquaresOptimizerAbstractTest.java
index afb479c92..c1c950532 100644
---
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/AbstractLeastSquaresOptimizerAbstractTest.java
+++
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/AbstractLeastSquaresOptimizerAbstractTest.java
@@ -41,9 +41,9 @@ import java.util.Arrays;
/**
* Some of the unit tests are re-implementations of the MINPACK <a
- * href="http://www.netlib.org/minpack/ex/file17">file17</a> and <a
- * href="http://www.netlib.org/minpack/ex/file22">file22</a> test files. The
- * redistribution policy for MINPACK is available <a
href="http://www.netlib.org/minpack/disclaimer">here</a>.
+ * href="https://www.netlib.org/minpack/ex/file17">file17</a> and <a
+ * href="https://www.netlib.org/minpack/ex/file22">file22</a> test files. The
+ * redistribution policy for MINPACK is available <a
href="https://www.netlib.org/minpack/disclaimer">here</a>.
* <p>
* <T> Concrete implementation of an optimizer.
*
diff --git
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithCholeskyTest.java
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithCholeskyTest.java
index 7e87211e4..47b5304ce 100644
---
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithCholeskyTest.java
+++
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithCholeskyTest.java
@@ -27,10 +27,10 @@ import java.io.IOException;
/**
* <p>Some of the unit tests are re-implementations of the MINPACK <a
- * href="http://www.netlib.org/minpack/ex/file17">file17</a> and <a
- * href="http://www.netlib.org/minpack/ex/file22">file22</a> test files.
+ * href="https://www.netlib.org/minpack/ex/file17">file17</a> and <a
+ * href="https://www.netlib.org/minpack/ex/file22">file22</a> test files.
* The redistribution policy for MINPACK is available <a
- * href="http://www.netlib.org/minpack/disclaimer">here</a>/
+ * href="https://www.netlib.org/minpack/disclaimer">here</a>/
*
*/
public class GaussNewtonOptimizerWithCholeskyTest
diff --git
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithLUTest.java
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithLUTest.java
index 2520a2566..eecc2afb3 100644
---
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithLUTest.java
+++
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithLUTest.java
@@ -27,10 +27,10 @@ import java.io.IOException;
/**
* <p>Some of the unit tests are re-implementations of the MINPACK <a
- * href="http://www.netlib.org/minpack/ex/file17">file17</a> and <a
- * href="http://www.netlib.org/minpack/ex/file22">file22</a> test files.
+ * href="https://www.netlib.org/minpack/ex/file17">file17</a> and <a
+ * href="https://www.netlib.org/minpack/ex/file22">file22</a> test files.
* The redistribution policy for MINPACK is available <a
- * href="http://www.netlib.org/minpack/disclaimer">here</a>/
+ * href="https://www.netlib.org/minpack/disclaimer">here</a>/
*
*/
public class GaussNewtonOptimizerWithLUTest
diff --git
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithQRTest.java
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithQRTest.java
index 2e22a9df5..7c4a4f00b 100644
---
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithQRTest.java
+++
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithQRTest.java
@@ -27,10 +27,10 @@ import java.io.IOException;
/**
* <p>Some of the unit tests are re-implementations of the MINPACK <a
- * href="http://www.netlib.org/minpack/ex/file17">file17</a> and <a
- * href="http://www.netlib.org/minpack/ex/file22">file22</a> test files.
+ * href="https://www.netlib.org/minpack/ex/file17">file17</a> and <a
+ * href="https://www.netlib.org/minpack/ex/file22">file22</a> test files.
* The redistribution policy for MINPACK is available <a
- * href="http://www.netlib.org/minpack/disclaimer">here</a>/
+ * href="https://www.netlib.org/minpack/disclaimer">here</a>/
*
*/
public class GaussNewtonOptimizerWithQRTest
diff --git
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithSVDTest.java
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithSVDTest.java
index 79810c77b..eb1801b52 100644
---
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithSVDTest.java
+++
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/GaussNewtonOptimizerWithSVDTest.java
@@ -34,10 +34,10 @@ import java.io.IOException;
/**
* <p>Some of the unit tests are re-implementations of the MINPACK <a
- * href="http://www.netlib.org/minpack/ex/file17">file17</a> and <a
- * href="http://www.netlib.org/minpack/ex/file22">file22</a> test files.
+ * href="https://www.netlib.org/minpack/ex/file17">file17</a> and <a
+ * href="https://www.netlib.org/minpack/ex/file22">file22</a> test files.
* The redistribution policy for MINPACK is available <a
- * href="http://www.netlib.org/minpack/disclaimer">here</a>/
+ * href="https://www.netlib.org/minpack/disclaimer">here</a>/
*
*/
public class GaussNewtonOptimizerWithSVDTest
diff --git
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/LevenbergMarquardtOptimizerTest.java
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/LevenbergMarquardtOptimizerTest.java
index 0cc28fb87..0a5283b5d 100644
---
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/LevenbergMarquardtOptimizerTest.java
+++
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/LevenbergMarquardtOptimizerTest.java
@@ -33,10 +33,10 @@ import org.junit.Test;
/**
* <p>Some of the unit tests are re-implementations of the MINPACK <a
- * href="http://www.netlib.org/minpack/ex/file17">file17</a> and <a
- * href="http://www.netlib.org/minpack/ex/file22">file22</a> test files.
+ * href="https://www.netlib.org/minpack/ex/file17">file17</a> and <a
+ * href="https://www.netlib.org/minpack/ex/file22">file22</a> test files.
* The redistribution policy for MINPACK is available <a
- * href="http://www.netlib.org/minpack/disclaimer">here</a>.
+ * href="https://www.netlib.org/minpack/disclaimer">here</a>.
*
*/
public class LevenbergMarquardtOptimizerTest
diff --git
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/MinpackTest.java
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/MinpackTest.java
index e56368a45..f269cf59b 100644
---
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/MinpackTest.java
+++
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/MinpackTest.java
@@ -30,10 +30,10 @@ import org.junit.Test;
/**
* <p>Some of the unit tests are re-implementations of the MINPACK <a
- * href="http://www.netlib.org/minpack/ex/file17">file17</a> and <a
- * href="http://www.netlib.org/minpack/ex/file22">file22</a> test files.
+ * href="https://www.netlib.org/minpack/ex/file17">file17</a> and <a
+ * href="https://www.netlib.org/minpack/ex/file22">file22</a> test files.
* The redistribution policy for MINPACK is available <a
- * href="http://www.netlib.org/minpack/disclaimer">here</a>, for
+ * href="https://www.netlib.org/minpack/disclaimer">here</a>, for
* convenience, it is reproduced below.</p>
* <table border="" align="center" bgcolor="#E0E0E0">
diff --git
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/StatisticalReferenceDataset.java
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/StatisticalReferenceDataset.java
index e257749d7..72ebfcc48 100644
---
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/StatisticalReferenceDataset.java
+++
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/fitting/leastsquares/StatisticalReferenceDataset.java
@@ -27,7 +27,7 @@ import
org.apache.commons.math4.legacy.analysis.MultivariateVectorFunction;
/**
* This class gives access to the statistical reference datasets provided by
the
* NIST (available
- * <a
href="http://www.itl.nist.gov/div898/strd/general/dataarchive.html">here</a>).
+ * <a
href="https://www.itl.nist.gov/div898/strd/general/dataarchive.html">here</a>).
* Instances of this class can be created by invocation of the
* {@link StatisticalReferenceDatasetFactory}.
*/
diff --git
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/gradient/NonLinearConjugateGradientOptimizerTest.java
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/gradient/NonLinearConjugateGradientOptimizerTest.java
index 9a2c39104..3bfd4806b 100644
---
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/gradient/NonLinearConjugateGradientOptimizerTest.java
+++
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/optim/nonlinear/scalar/gradient/NonLinearConjugateGradientOptimizerTest.java
@@ -37,10 +37,10 @@ import org.junit.Test;
/**
* <p>Some of the unit tests are re-implementations of the MINPACK <a
- * href="http://www.netlib.org/minpack/ex/file17">file17</a> and <a
- * href="http://www.netlib.org/minpack/ex/file22">file22</a> test files.
+ * href="https://www.netlib.org/minpack/ex/file17">file17</a> and <a
+ * href="https://www.netlib.org/minpack/ex/file22">file22</a> test files.
* The redistribution policy for MINPACK is available <a
- * href="http://www.netlib.org/minpack/disclaimer">here</a>, for
+ * href="https://www.netlib.org/minpack/disclaimer">here</a>, for
* convenience, it is reproduced below.</p>
*
* <table style="text-align: center; background-color: #E0E0E0" border="">
diff --git
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/special/BesselJTest.java
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/special/BesselJTest.java
index 52c0b06f9..ed00d1f30 100644
---
a/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/special/BesselJTest.java
+++
b/commons-math-legacy/src/test/java/org/apache/commons/math4/legacy/special/BesselJTest.java
@@ -26,7 +26,7 @@ public class BesselJTest {
/**
* Reference data for the {@link BesselJ#value(double, double)} function.
This data
- * was generated with the following <a
href="http://www.r-project.org/">R</a> script.
+ * was generated with the following <a
href="https://www.r-project.org/">R</a> script.
*
* <pre>
* smallxs = 10 ** (-(seq(0,8,.5)))
diff --git
a/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/SquareNeighbourhood.java
b/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/SquareNeighbourhood.java
index 890512b19..3d341c541 100644
---
a/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/SquareNeighbourhood.java
+++
b/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/SquareNeighbourhood.java
@@ -24,13 +24,13 @@ package org.apache.commons.math4.neuralnet;
*/
public enum SquareNeighbourhood {
/**
- * <a href="http://en.wikipedia.org/wiki/Von_Neumann_neighborhood">
+ * <a href="https://en.wikipedia.org/wiki/Von_Neumann_neighborhood">
* Von Neumann neighbourhood</a>: in two dimensions, each (internal)
* neuron has four neighbours.
*/
VON_NEUMANN,
/**
- * <a href="http://en.wikipedia.org/wiki/Moore_neighborhood">
+ * <a href="https://en.wikipedia.org/wiki/Moore_neighborhood">
* Moore neighbourhood</a>: in two dimensions, each (internal)
* neuron has eight neighbours.
*/
diff --git
a/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/sofm/KohonenUpdateAction.java
b/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/sofm/KohonenUpdateAction.java
index 98ab2dc88..ab329b976 100644
---
a/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/sofm/KohonenUpdateAction.java
+++
b/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/sofm/KohonenUpdateAction.java
@@ -29,7 +29,7 @@ import org.apache.commons.math4.neuralnet.Neuron;
import org.apache.commons.math4.neuralnet.UpdateAction;
/**
- * Update formula for <a href="http://en.wikipedia.org/wiki/Kohonen">
+ * Update formula for <a href="https://en.wikipedia.org/wiki/Kohonen">
* Kohonen's Self-Organizing Map</a>.
* <br>
* The {@link #update(Network,double[]) update} method modifies the
diff --git
a/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/twod/NeuronSquareMesh2D.java
b/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/twod/NeuronSquareMesh2D.java
index d3b7b937e..f6be18c4c 100644
---
a/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/twod/NeuronSquareMesh2D.java
+++
b/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/twod/NeuronSquareMesh2D.java
@@ -37,7 +37,7 @@ import
org.apache.commons.math4.neuralnet.twod.util.LocationFinder;
* Each neuron defines one surface element.
* <br>
* This network is primarily intended to represent a
- * <a href="http://en.wikipedia.org/wiki/Kohonen">
+ * <a href="https://en.wikipedia.org/wiki/Kohonen">
* Self Organizing Feature Map</a>.
*
* @see org.apache.commons.math4.neuralnet.sofm
diff --git
a/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/twod/util/UnifiedDistanceMatrix.java
b/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/twod/util/UnifiedDistanceMatrix.java
index d84abfc4e..60749c20b 100644
---
a/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/twod/util/UnifiedDistanceMatrix.java
+++
b/commons-math-neuralnet/src/main/java/org/apache/commons/math4/neuralnet/twod/util/UnifiedDistanceMatrix.java
@@ -22,7 +22,7 @@ import org.apache.commons.math4.neuralnet.Neuron;
import org.apache.commons.math4.neuralnet.twod.NeuronSquareMesh2D;
/**
- * <a href="http://en.wikipedia.org/wiki/U-Matrix">U-Matrix</a>
+ * <a href="https://en.wikipedia.org/wiki/U-Matrix">U-Matrix</a>
* visualization of high-dimensional data projection.
* The 8 individual inter-units distances will be
* {@link #computeImage(NeuronSquareMesh2D) computed}. They will be
diff --git
a/commons-math-transform/src/main/java/org/apache/commons/math4/transform/FastHadamardTransform.java
b/commons-math-transform/src/main/java/org/apache/commons/math4/transform/FastHadamardTransform.java
index 89cd8b2c1..caafd0549 100644
---
a/commons-math-transform/src/main/java/org/apache/commons/math4/transform/FastHadamardTransform.java
+++
b/commons-math-transform/src/main/java/org/apache/commons/math4/transform/FastHadamardTransform.java
@@ -21,7 +21,7 @@ import java.util.function.UnaryOperator;
import org.apache.commons.numbers.core.ArithmeticUtils;
/**
- * <a href="http://www.archive.chipcenter.com/dsp/DSP000517F1.html">Fast
Hadamard Transform</a> (FHT).
+ * <a href="https://www.archive.chipcenter.com/dsp/DSP000517F1.html">Fast
Hadamard Transform</a> (FHT).
* <p>
* The FHT can also transform integer vectors into integer vectors.
* However, this transform cannot be inverted directly, due to a scaling
@@ -171,7 +171,7 @@ public class FastHadamardTransform implements RealTransform
{
* understood with the above example (for {@code N = 8}).
* <li>The output vector {@code y} is now in the last column of
* {@code hadm}.</li>
- * <li><em>Algorithm from <a
href="http://www.archive.chipcenter.com/dsp/DSP000517F1.html">chipcenter</a>.</em></li>
+ * <li><em>Algorithm from <a
href="https://www.archive.chipcenter.com/dsp/DSP000517F1.html">chipcenter</a>.</em></li>
* </ol>
* <h3>Visually</h3>
* <table border="" style="text-align: center">