You are viewing a plain text version of this content. The canonical link for it is here.
Posted to commits@commons.apache.org by ps...@apache.org on 2009/09/05 19:37:05 UTC

svn commit: r811685 [8/24] - in /commons/proper/math/trunk: ./ src/main/java/org/apache/commons/math/ src/main/java/org/apache/commons/math/analysis/ src/main/java/org/apache/commons/math/analysis/integration/ src/main/java/org/apache/commons/math/anal...

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/VectorialPointValuePair.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/VectorialPointValuePair.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/VectorialPointValuePair.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/VectorialPointValuePair.java Sat Sep  5 17:36:48 2009
@@ -19,7 +19,7 @@
 
 import java.io.Serializable;
 
-/** 
+/**
  * This class holds a point and the vectorial value of an objective function at this point.
  * <p>This is a simple immutable container.</p>
  * @see RealPointValuePair

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/DirectSearchOptimizer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/DirectSearchOptimizer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/DirectSearchOptimizer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/DirectSearchOptimizer.java Sat Sep  5 17:36:48 2009
@@ -32,7 +32,7 @@
 import org.apache.commons.math.optimization.RealPointValuePair;
 import org.apache.commons.math.optimization.SimpleScalarValueChecker;
 
-/** 
+/**
  * This class implements simplex-based direct search optimization
  * algorithms.
  *
@@ -78,7 +78,7 @@
  * algorithms.</p>
  *
  * implements MultivariateRealOptimizer since 2.0
- * 
+ *
  * @see MultivariateRealFunction
  * @see NelderMead
  * @see MultiDirectional

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/MultiDirectional.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/MultiDirectional.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/MultiDirectional.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/MultiDirectional.java Sat Sep  5 17:36:48 2009
@@ -24,7 +24,7 @@
 import org.apache.commons.math.optimization.RealConvergenceChecker;
 import org.apache.commons.math.optimization.RealPointValuePair;
 
-/** 
+/**
  * This class implements the multi-directional direct search method.
  *
  * @version $Revision$ $Date$

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/NelderMead.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/NelderMead.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/NelderMead.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/direct/NelderMead.java Sat Sep  5 17:36:48 2009
@@ -23,7 +23,7 @@
 import org.apache.commons.math.optimization.OptimizationException;
 import org.apache.commons.math.optimization.RealPointValuePair;
 
-/** 
+/**
  * This class implements the Nelder-Mead direct search method.
  *
  * @version $Revision$ $Date$

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/fitting/ParametricRealFunction.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/fitting/ParametricRealFunction.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/fitting/ParametricRealFunction.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/fitting/ParametricRealFunction.java Sat Sep  5 17:36:48 2009
@@ -22,7 +22,7 @@
 /**
  * An interface representing a real function that depends on one independent
  * variable plus some extra parameters.
- *  
+ *
  * @version $Revision$ $Date$
  */
 public interface ParametricRealFunction {

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/fitting/PolynomialFitter.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/fitting/PolynomialFitter.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/fitting/PolynomialFitter.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/fitting/PolynomialFitter.java Sat Sep  5 17:36:48 2009
@@ -97,7 +97,7 @@
             }
             return y;
         }
-        
+
     }
 
 }

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/AbstractLeastSquaresOptimizer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/AbstractLeastSquaresOptimizer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/AbstractLeastSquaresOptimizer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/AbstractLeastSquaresOptimizer.java Sat Sep  5 17:36:48 2009
@@ -63,7 +63,7 @@
     /** Convergence checker. */
     protected VectorialConvergenceChecker checker;
 
-    /** 
+    /**
      * Jacobian matrix.
      * <p>This matrix is in canonical form just after the calls to
      * {@link #updateJacobian()}, but may be modified by the solver
@@ -168,7 +168,7 @@
         }
     }
 
-    /** 
+    /**
      * Update the jacobian matrix.
      * @exception FunctionEvaluationException if the function jacobian
      * cannot be evaluated or its dimension doesn't match problem dimension
@@ -189,7 +189,7 @@
         }
     }
 
-    /** 
+    /**
      * Update the residuals array and cost function value.
      * @exception FunctionEvaluationException if the function cannot be evaluated
      * or its dimension doesn't match problem dimension or maximal number of
@@ -217,14 +217,14 @@
 
     }
 
-    /** 
+    /**
      * Get the Root Mean Square value.
      * Get the Root Mean Square value, i.e. the root of the arithmetic
      * mean of the square of all weighted residuals. This is related to the
      * criterion that is minimized by the optimizer as follows: if
      * <em>c</em> if the criterion, and <em>n</em> is the number of
      * measurements, then the RMS is <em>sqrt (c/n)</em>.
-     * 
+     *
      * @return RMS value
      */
     public double getRMS() {
@@ -357,4 +357,4 @@
     abstract protected VectorialPointValuePair doOptimize()
         throws FunctionEvaluationException, OptimizationException, IllegalArgumentException;
 
-}
\ No newline at end of file
+}

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/AbstractScalarDifferentiableOptimizer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/AbstractScalarDifferentiableOptimizer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/AbstractScalarDifferentiableOptimizer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/AbstractScalarDifferentiableOptimizer.java Sat Sep  5 17:36:48 2009
@@ -138,7 +138,7 @@
         }
     }
 
-    /** 
+    /**
      * Compute the gradient vector.
      * @param evaluationPoint point at which the gradient must be evaluated
      * @return gradient at the specified point
@@ -150,7 +150,7 @@
         return gradient.value(evaluationPoint);
     }
 
-    /** 
+    /**
      * Compute the objective function value.
      * @param evaluationPoint point at which the objective function must be evaluated
      * @return objective function value at specified point
@@ -198,4 +198,4 @@
     abstract protected RealPointValuePair doOptimize()
         throws FunctionEvaluationException, OptimizationException, IllegalArgumentException;
 
-}
\ No newline at end of file
+}

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/GaussNewtonOptimizer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/GaussNewtonOptimizer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/GaussNewtonOptimizer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/GaussNewtonOptimizer.java Sat Sep  5 17:36:48 2009
@@ -27,7 +27,7 @@
 import org.apache.commons.math.optimization.OptimizationException;
 import org.apache.commons.math.optimization.VectorialPointValuePair;
 
-/** 
+/**
  * Gauss-Newton least-squares solver.
  * <p>
  * This class solve a least-square problem by solving the normal equations

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/LevenbergMarquardtOptimizer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/LevenbergMarquardtOptimizer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/LevenbergMarquardtOptimizer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/LevenbergMarquardtOptimizer.java Sat Sep  5 17:36:48 2009
@@ -23,7 +23,7 @@
 import org.apache.commons.math.optimization.VectorialPointValuePair;
 
 
-/** 
+/**
  * This class solves a least squares problem using the Levenberg-Marquardt algorithm.
  *
  * <p>This implementation <em>should</em> work even for over-determined systems
@@ -138,7 +138,7 @@
      * and the columns of the jacobian. */
     private double orthoTolerance;
 
-    /** 
+    /**
      * Build an optimizer for least squares problems.
      * <p>The default values for the algorithm settings are:
      *   <ul>
@@ -163,7 +163,7 @@
 
     }
 
-    /** 
+    /**
      * Set the positive input variable used in determining the initial step bound.
      * This bound is set to the product of initialStepBoundFactor and the euclidean
      * norm of diag*x if nonzero, or else to initialStepBoundFactor itself. In most
@@ -176,18 +176,18 @@
         this.initialStepBoundFactor = initialStepBoundFactor;
     }
 
-    /** 
+    /**
      * Set the desired relative error in the sum of squares.
-     * 
+     *
      * @param costRelativeTolerance desired relative error in the sum of squares
      */
     public void setCostRelativeTolerance(double costRelativeTolerance) {
         this.costRelativeTolerance = costRelativeTolerance;
     }
 
-    /** 
+    /**
      * Set the desired relative error in the approximate solution parameters.
-     * 
+     *
      * @param parRelativeTolerance desired relative error
      * in the approximate solution parameters
      */
@@ -195,9 +195,9 @@
         this.parRelativeTolerance = parRelativeTolerance;
     }
 
-    /** 
+    /**
      * Set the desired max cosine on the orthogonality.
-     * 
+     *
      * @param orthoTolerance desired max cosine on the orthogonality
      * between the function vector and the columns of the jacobian
      */
@@ -430,7 +430,7 @@
 
     }
 
-    /** 
+    /**
      * Determine 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>
@@ -444,7 +444,7 @@
      *   <li>Jorge   J. More</li>
      * </ul>
      * <p>Luc Maisonobe did the Java translation.</p>
-     * 
+     *
      * @param qy array containing qTy
      * @param delta upper bound on the euclidean norm of diagR * lmDir
      * @param diag diagonal matrix
@@ -495,7 +495,7 @@
         if (rank == solvedCols) {
             for (int j = 0; j < solvedCols; ++j) {
                 int pj = permutation[j];
-                work1[pj] *= diag[pj] / dxNorm; 
+                work1[pj] *= diag[pj] / dxNorm;
             }
             sum2 = 0;
             for (int j = 0; j < solvedCols; ++j) {
@@ -570,7 +570,7 @@
             // compute the Newton correction
             for (int j = 0; j < solvedCols; ++j) {
                 int pj = permutation[j];
-                work1[pj] = work3[pj] * diag[pj] / dxNorm; 
+                work1[pj] = work3[pj] * diag[pj] / dxNorm;
             }
             for (int j = 0; j < solvedCols; ++j) {
                 int pj = permutation[j];
@@ -600,7 +600,7 @@
         }
     }
 
-    /** 
+    /**
      * 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>
@@ -614,7 +614,7 @@
      *   <li>Jorge   J. More</li>
      * </ul>
      * <p>Luc Maisonobe did the Java translation.</p>
-     * 
+     *
      * @param qy array containing qTy
      * @param diag diagonal matrix
      * @param lmDiag diagonal elements associated with lmDir
@@ -723,7 +723,7 @@
 
     }
 
-    /** 
+    /**
      * Decompose a matrix A as A.P = Q.R using Householder transforms.
      * <p>As suggested in the P. Lascaux and R. Theodor book
      * <i>Analyse num&eacute;rique matricielle appliqu&eacute;e &agrave;
@@ -816,9 +816,9 @@
 
     }
 
-    /** 
+    /**
      * Compute the product Qt.y for some Q.R. decomposition.
-     * 
+     *
      * @param y vector to multiply (will be overwritten with the result)
      */
     private void qTy(double[] y) {

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/NonLinearConjugateGradientOptimizer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/NonLinearConjugateGradientOptimizer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/NonLinearConjugateGradientOptimizer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/NonLinearConjugateGradientOptimizer.java Sat Sep  5 17:36:48 2009
@@ -27,7 +27,7 @@
 import org.apache.commons.math.optimization.DifferentiableMultivariateRealOptimizer;
 import org.apache.commons.math.optimization.RealPointValuePair;
 
-/** 
+/**
  * Non-linear conjugate gradient optimizer.
  * <p>
  * This class supports both the Fletcher-Reeves and the Polak-Ribi&egrave;re
@@ -189,7 +189,7 @@
                     double deltaMid = 0;
                     for (int i = 0; i < r.length; ++i) {
                         deltaMid += r[i] * steepestDescent[i];
-                    }                    
+                    }
                     beta = (delta - deltaMid) / deltaOld;
                 }
                 steepestDescent = newSteepestDescent;

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/Preconditioner.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/Preconditioner.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/Preconditioner.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/general/Preconditioner.java Sat Sep  5 17:36:48 2009
@@ -19,7 +19,7 @@
 
 import org.apache.commons.math.FunctionEvaluationException;
 
-/** 
+/**
  * This interface represents a preconditioner for differentiable scalar
  * objective function optimizers.
  * @version $Revision$ $Date$
@@ -27,7 +27,7 @@
  */
 public interface Preconditioner {
 
-    /** 
+    /**
      * Precondition a search direction.
      * <p>
      * The returned preconditioned search direction must be computed fast or

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/AbstractLinearOptimizer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/AbstractLinearOptimizer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/AbstractLinearOptimizer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/AbstractLinearOptimizer.java Sat Sep  5 17:36:48 2009
@@ -115,4 +115,4 @@
     abstract protected RealPointValuePair doOptimize()
         throws OptimizationException;
 
-}
\ No newline at end of file
+}

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearConstraint.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearConstraint.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearConstraint.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearConstraint.java Sat Sep  5 17:36:48 2009
@@ -188,7 +188,7 @@
     @Override
     public boolean equals(Object other) {
 
-      if (this == other) { 
+      if (this == other) {
         return true;
       }
 
@@ -209,7 +209,7 @@
       }
 
     }
-    
+
     /** {@inheritDoc} */
     @Override
     public int hashCode() {

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearObjectiveFunction.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearObjectiveFunction.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearObjectiveFunction.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearObjectiveFunction.java Sat Sep  5 17:36:48 2009
@@ -105,7 +105,7 @@
     @Override
     public boolean equals(Object other) {
 
-      if (this == other) { 
+      if (this == other) {
         return true;
       }
 
@@ -124,7 +124,7 @@
       }
 
     }
-    
+
     /** {@inheritDoc} */
     @Override
     public int hashCode() {

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearOptimizer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearOptimizer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearOptimizer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/LinearOptimizer.java Sat Sep  5 17:36:48 2009
@@ -23,7 +23,7 @@
 import org.apache.commons.math.optimization.OptimizationException;
 import org.apache.commons.math.optimization.RealPointValuePair;
 
-/** 
+/**
  * This interface represents an optimization algorithm for linear problems.
  * <p>Optimization algorithms find the input point set that either {@link GoalType
  * maximize or minimize} an objective function. In the linear case the form of

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/NoFeasibleSolutionException.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/NoFeasibleSolutionException.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/NoFeasibleSolutionException.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/NoFeasibleSolutionException.java Sat Sep  5 17:36:48 2009
@@ -30,7 +30,7 @@
     /** Serializable version identifier. */
     private static final long serialVersionUID = -3044253632189082760L;
 
-    /** 
+    /**
      * Simple constructor using a default message.
      */
     public NoFeasibleSolutionException() {

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/SimplexSolver.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/SimplexSolver.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/SimplexSolver.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/SimplexSolver.java Sat Sep  5 17:36:48 2009
@@ -29,11 +29,11 @@
  */
 public class SimplexSolver extends AbstractLinearOptimizer {
 
-    /** Default amount of error to accept in floating point comparisons. */ 
+    /** Default amount of error to accept in floating point comparisons. */
     private static final double DEFAULT_EPSILON = 1.0e-6;
 
-    /** Amount of error to accept in floating point comparisons. */ 
-    protected final double epsilon;  
+    /** Amount of error to accept in floating point comparisons. */
+    protected final double epsilon;
 
     /**
      * Build a simplex solver with default settings.
@@ -83,7 +83,7 @@
                 final double ratio = rhs / entry;
                 if (ratio < minRatio) {
                     minRatio = ratio;
-                    minRatioPos = i; 
+                    minRatioPos = i;
                 }
             }
         }

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/SimplexTableau.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/SimplexTableau.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/SimplexTableau.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/SimplexTableau.java Sat Sep  5 17:36:48 2009
@@ -37,7 +37,7 @@
 
 /**
  * A tableau for use in the Simplex method.
- * 
+ *
  * <p>
  * Example:
  * <pre>
@@ -86,9 +86,9 @@
     /** Number of artificial variables. */
     protected int numArtificialVariables;
 
-    /** Amount of error to accept in floating point comparisons. */ 
+    /** Amount of error to accept in floating point comparisons. */
     protected final double epsilon;
-    
+
     /**
      * Build a tableau for a linear problem.
      * @param f linear objective function
@@ -174,8 +174,8 @@
             // artificial variables
             if ((constraint.getRelationship() == Relationship.EQ) ||
                     (constraint.getRelationship() == Relationship.GEQ)) {
-                matrix[0][getArtificialVariableOffset() + artificialVar] = 1; 
-                matrix[row][getArtificialVariableOffset() + artificialVar++] = 1; 
+                matrix[0][getArtificialVariableOffset() + artificialVar] = 1;
+                matrix[row][getArtificialVariableOffset() + artificialVar++] = 1;
             }
         }
 
@@ -214,7 +214,7 @@
                                         constraint.getRelationship().oppositeRelationship(),
                                         -1 * constraint.getValue());
         }
-        return new LinearConstraint(constraint.getCoefficients(), 
+        return new LinearConstraint(constraint.getCoefficients(),
                                     constraint.getRelationship(), constraint.getValue());
     }
 
@@ -282,7 +282,7 @@
     private Integer getBasicRowForSolution(final int col) {
         return getBasicRow(col, false);
     }
-    
+
     /**
      * Checks whether the given column is basic.
      * @param col index of the column to check
@@ -329,12 +329,12 @@
      * @param dest the destination array
      */
     private void copyArray(final double[] src, final double[] dest) {
-        System.arraycopy(src, 0, dest, getNumObjectiveFunctions(), src.length); 
+        System.arraycopy(src, 0, dest, getNumObjectiveFunctions(), src.length);
     }
 
     /**
      * Get the current solution.
-     * 
+     *
      * @return current solution
      */
     protected RealPointValuePair getSolution() {
@@ -345,7 +345,7 @@
       for (int i = 0; i < coefficients.length; i++) {
           Integer basicRow = getBasicRowForSolution(getNumObjectiveFunctions() + i);
           if (basicRows.contains(basicRow)) {
-              // if multiple variables can take a given value 
+              // if multiple variables can take a given value
               // then we choose the first and set the rest equal to 0
               coefficients[i] = 0;
           } else {
@@ -449,7 +449,7 @@
     protected final int getRhsOffset() {
         return getWidth() - 1;
     }
-    
+
     /**
      * Returns the offset of the extra decision variable added when there is a
      * negative decision variable in the original problem.
@@ -510,7 +510,7 @@
     @Override
     public boolean equals(Object other) {
 
-      if (this == other) { 
+      if (this == other) {
         return true;
       }
 
@@ -536,7 +536,7 @@
       }
 
     }
-    
+
     /** {@inheritDoc} */
     @Override
     public int hashCode() {

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/UnboundedSolutionException.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/UnboundedSolutionException.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/UnboundedSolutionException.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/linear/UnboundedSolutionException.java Sat Sep  5 17:36:48 2009
@@ -30,7 +30,7 @@
     /** Serializable version identifier. */
     private static final long serialVersionUID = 940539497277290619L;
 
-    /** 
+    /**
      * Simple constructor using a default message.
      */
     public UnboundedSolutionException() {

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/AbstractUnivariateRealOptimizer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/AbstractUnivariateRealOptimizer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/AbstractUnivariateRealOptimizer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/AbstractUnivariateRealOptimizer.java Sat Sep  5 17:36:48 2009
@@ -27,7 +27,7 @@
 /**
  * Provide a default implementation for several functions useful to generic
  * optimizers.
- *  
+ *
  * @version $Revision$ $Date$
  * @since 2.0
  */
@@ -54,7 +54,7 @@
      * FunctionEvaluationExceptionFunctionEvaluationException
      * @param defaultAbsoluteAccuracy maximum absolute error
      * @param defaultMaximalIterationCount maximum number of iterations
-     * @throws IllegalArgumentException if f is null or the 
+     * @throws IllegalArgumentException if f is null or the
      * defaultAbsoluteAccuracy is not valid
      */
     protected AbstractUnivariateRealOptimizer(final int defaultMaximalIterationCount,
@@ -87,7 +87,7 @@
 
     /**
      * Convenience function for implementations.
-     * 
+     *
      * @param x the result to set
      * @param fx the result to set
      * @param iterationCount the iteration count to set
@@ -122,7 +122,7 @@
         return evaluations;
     }
 
-    /** 
+    /**
      * Compute the objective function value.
      * @param f objective function
      * @param point point at which the objective function must be evaluated

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/BrentOptimizer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/BrentOptimizer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/BrentOptimizer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/BrentOptimizer.java Sat Sep  5 17:36:48 2009
@@ -25,12 +25,12 @@
  * Implements Richard Brent's algorithm (from his book "Algorithms for
  * Minimization without Derivatives", p. 79) for finding minima of real
  * univariate functions.
- *  
+ *
  * @version $Revision$ $Date$
  * @since 2.0
  */
 public class BrentOptimizer extends AbstractUnivariateRealOptimizer {
-    
+
     /**
      * Golden section.
      */
@@ -49,7 +49,7 @@
         throws MaxIterationsExceededException, FunctionEvaluationException {
         return optimize(f, goalType, min, max);
     }
-    
+
     /** {@inheritDoc} */
     public double optimize(final UnivariateRealFunction f, final GoalType goalType,
                            final double min, final double max)
@@ -57,7 +57,7 @@
         clearResult();
         return localMin(f, goalType, min, max, relativeAccuracy, absoluteAccuracy);
     }
-    
+
     /**
      * Find the minimum of the function {@code f} within the interval {@code (a, b)}.
      *
@@ -80,7 +80,7 @@
      * @throws MaxIterationsExceededException if the maximum iteration count
      * is exceeded.
      * @throws FunctionEvaluationException if an error occurs evaluating
-     * the function. 
+     * the function.
      */
     private double localMin(final UnivariateRealFunction f, final GoalType goalType,
                             double a, double b, final double eps, final double t)

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/package.html
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/package.html?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/package.html (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/optimization/univariate/package.html Sat Sep  5 17:36:48 2009
@@ -19,4 +19,4 @@
     <body>
      Univariate real functions minimum finding algorithms.
     </body>
-</html>
\ No newline at end of file
+</html>

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/AbstractRandomGenerator.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/AbstractRandomGenerator.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/AbstractRandomGenerator.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/AbstractRandomGenerator.java Sat Sep  5 17:36:48 2009
@@ -21,7 +21,7 @@
 /**
  * Abstract class implementing the {@link  RandomGenerator} interface.
  * Default implementations for all methods other than {@link #nextDouble()} and
- * {@link #setSeed(long)} are provided. 
+ * {@link #setSeed(long)} are provided.
  * <p>
  * All data generation methods are based on <code>nextDouble().</code>
  * Concrete implementations <strong>must</strong> override
@@ -33,26 +33,26 @@
  * @version $Revision$ $Date$
  */
 public abstract class AbstractRandomGenerator implements RandomGenerator {
-    
-    /** 
-     * Cached random normal value.  The default implementation for 
+
+    /**
+     * Cached random normal value.  The default implementation for
      * {@link #nextGaussian} generates pairs of values and this field caches the
      * second value so that the full algorithm is not executed for every
      * activation.  The value <code>Double.NaN</code> signals that there is
      * no cached value.  Use {@link #clear} to clear the cached value.
      */
     private double cachedNormalDeviate = Double.NaN;
-    
+
     /**
      * Construct a RandomGenerator.
      */
     public AbstractRandomGenerator() {
         super();
-        
+
     }
-    
+
     /**
-     * Clears the cache used by the default implementation of 
+     * Clears the cache used by the default implementation of
      * {@link #nextGaussian}. Implemementations that do not override the
      * default implementation of <code>nextGaussian</code> should call this
      * method in the implementation of {@link #setSeed(long)}
@@ -79,27 +79,27 @@
     }
 
     /**
-     * Sets the seed of the underyling random number generator using a 
+     * Sets the seed of the underyling random number generator using a
      * <code>long</code> seed.  Sequences of values generated starting with the
      * same seeds should be identical.
      * <p>
-     * Implementations that do not override the default implementation of 
+     * Implementations that do not override the default implementation of
      * <code>nextGaussian</code> should include a call to {@link #clear} in the
      * implementation of this method.</p>
      *
      * @param seed the seed value
      */
-    public abstract void setSeed(long seed);  
+    public abstract void setSeed(long seed);
 
     /**
-     * Generates random bytes and places them into a user-supplied 
-     * byte array.  The number of random bytes produced is equal to 
+     * Generates random bytes and places them into a user-supplied
+     * byte array.  The number of random bytes produced is equal to
      * the length of the byte array.
      * <p>
      * The default implementation fills the array with bytes extracted from
      * random integers generated using {@link #nextInt}.</p>
-     * 
-     * @param bytes the non-null byte array in which to put the 
+     *
+     * @param bytes the non-null byte array in which to put the
      * random bytes
      */
     public void nextBytes(byte[] bytes) {
@@ -120,11 +120,11 @@
 
      /**
      * Returns the next pseudorandom, uniformly distributed <code>int</code>
-     * value from this random number generator's sequence.  
+     * value from this random number generator's sequence.
      * All 2<font size="-1"><sup>32</sup></font> possible <tt>int</tt> values
-     * should be produced with  (approximately) equal probability. 
+     * should be produced with  (approximately) equal probability.
      * <p>
-     * The default implementation provided here returns 
+     * The default implementation provided here returns
      * <pre>
      * <code>(int) (nextDouble() * Integer.MAX_VALUE)</code>
      * </pre></p>
@@ -139,9 +139,9 @@
     /**
      * Returns a pseudorandom, uniformly distributed <tt>int</tt> value
      * between 0 (inclusive) and the specified value (exclusive), drawn from
-     * this random number generator's sequence. 
-     * <p>  
-     * The default implementation returns 
+     * this random number generator's sequence.
+     * <p>
+     * The default implementation returns
      * <pre>
      * <code>(int) (nextDouble() * n</code>
      * </pre></p>
@@ -163,11 +163,11 @@
 
      /**
      * Returns the next pseudorandom, uniformly distributed <code>long</code>
-     * value from this random number generator's sequence.  All 
-     * 2<font size="-1"><sup>64</sup></font> possible <tt>long</tt> values 
-     * should be produced with (approximately) equal probability. 
-     * <p>  
-     * The default implementation returns 
+     * value from this random number generator's sequence.  All
+     * 2<font size="-1"><sup>64</sup></font> possible <tt>long</tt> values
+     * should be produced with (approximately) equal probability.
+     * <p>
+     * The default implementation returns
      * <pre>
      * <code>(long) (nextDouble() * Long.MAX_VALUE)</code>
      * </pre></p>
@@ -182,13 +182,13 @@
     /**
      * Returns the next pseudorandom, uniformly distributed
      * <code>boolean</code> value from this random number generator's
-     * sequence.  
-     * <p>  
-     * The default implementation returns 
+     * sequence.
+     * <p>
+     * The default implementation returns
      * <pre>
      * <code>nextDouble() <= 0.5</code>
      * </pre></p>
-     * 
+     *
      * @return  the next pseudorandom, uniformly distributed
      * <code>boolean</code> value from this random number generator's
      * sequence
@@ -200,9 +200,9 @@
      /**
      * Returns the next pseudorandom, uniformly distributed <code>float</code>
      * value between <code>0.0</code> and <code>1.0</code> from this random
-     * number generator's sequence.  
-     * <p>  
-     * The default implementation returns 
+     * number generator's sequence.
+     * <p>
+     * The default implementation returns
      * <pre>
      * <code>(float) nextDouble() </code>
      * </pre></p>
@@ -216,18 +216,18 @@
     }
 
     /**
-     * Returns the next pseudorandom, uniformly distributed 
+     * Returns the next pseudorandom, uniformly distributed
      * <code>double</code> value between <code>0.0</code> and
-     * <code>1.0</code> from this random number generator's sequence.  
+     * <code>1.0</code> from this random number generator's sequence.
      * <p>
      * This method provides the underlying source of random data used by the
-     * other methods.</p>   
+     * other methods.</p>
      *
-     * @return  the next pseudorandom, uniformly distributed 
+     * @return  the next pseudorandom, uniformly distributed
      *  <code>double</code> value between <code>0.0</code> and
      *  <code>1.0</code> from this random number generator's sequence
-     */  
-    public abstract double nextDouble();  
+     */
+    public abstract double nextDouble();
 
     /**
      * Returns the next pseudorandom, Gaussian ("normally") distributed
@@ -235,15 +235,15 @@
      * deviation <code>1.0</code> from this random number generator's sequence.
      * <p>
      * The default implementation uses the <em>Polar Method</em>
-     * due to G.E.P. Box, M.E. Muller and G. Marsaglia, as described in 
+     * due to G.E.P. Box, M.E. Muller and G. Marsaglia, as described in
      * D. Knuth, <u>The Art of Computer Programming</u>, 3.4.1C.</p>
      * <p>
      * The algorithm generates a pair of independent random values.  One of
      * these is cached for reuse, so the full algorithm is not executed on each
      * activation.  Implementations that do not override this method should
-     * make sure to call {@link #clear} to clear the cached value in the 
+     * make sure to call {@link #clear} to clear the cached value in the
      * implementation of {@link #setSeed(long)}.</p>
-     * 
+     *
      * @return  the next pseudorandom, Gaussian ("normally") distributed
      * <code>double</code> value with mean <code>0.0</code> and
      * standard deviation <code>1.0</code> from this random number
@@ -258,15 +258,15 @@
         double v1 = 0;
         double v2 = 0;
         double s = 1;
-        while (s >=1 ) { 
-            v1 = 2 * nextDouble() - 1; 
-            v2 = 2 * nextDouble() - 1; 
+        while (s >=1 ) {
+            v1 = 2 * nextDouble() - 1;
+            v2 = 2 * nextDouble() - 1;
             s = v1 * v1 + v2 * v2;
         }
         if (s != 0) {
-            s = Math.sqrt(-2 * Math.log(s) / s);   
+            s = Math.sqrt(-2 * Math.log(s) / s);
         }
         cachedNormalDeviate = v2 * s;
-        return v1 * s;      
+        return v1 * s;
     }
 }

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/BitsStreamGenerator.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/BitsStreamGenerator.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/BitsStreamGenerator.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/BitsStreamGenerator.java Sat Sep  5 17:36:48 2009
@@ -74,7 +74,7 @@
         }
         int random = next(32);
         while (i < bytes.length) {
-            bytes[i++] = (byte) (random & 0xff); 
+            bytes[i++] = (byte) (random & 0xff);
             random     = random >> 8;
         }
     }

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/CorrelatedRandomVectorGenerator.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/CorrelatedRandomVectorGenerator.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/CorrelatedRandomVectorGenerator.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/CorrelatedRandomVectorGenerator.java Sat Sep  5 17:36:48 2009
@@ -22,8 +22,8 @@
 import org.apache.commons.math.linear.NotPositiveDefiniteMatrixException;
 import org.apache.commons.math.linear.RealMatrix;
 
-/** 
- * A {@link RandomVectorGenerator} that generates vectors with with 
+/**
+ * A {@link RandomVectorGenerator} that generates vectors with with
  * correlated components.
  * <p>Random vectors with correlated components are built by combining
  * the uncorrelated components of another random vector in such a way that

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/EmpiricalDistribution.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/EmpiricalDistribution.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/EmpiricalDistribution.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/EmpiricalDistribution.java Sat Sep  5 17:36:48 2009
@@ -44,7 +44,7 @@
  * build grouped frequency histograms representing the input data or to
  * generate random values "like" those in the input file -- i.e., the values
  * generated will follow the distribution of the values in the file.</p>
- * 
+ *
  * @version $Revision$ $Date$
  */
 public interface EmpiricalDistribution {
@@ -52,14 +52,14 @@
     /**
      * Computes the empirical distribution from the provided
      * array of numbers.
-     * 
+     *
      * @param dataArray the data array
      */
     void load(double[] dataArray);
 
     /**
      * Computes the empirical distribution from the input file.
-     * 
+     *
      * @param file the input file
      * @throws IOException if an IO error occurs
      */
@@ -67,7 +67,7 @@
 
     /**
      * Computes the empirical distribution using data read from a URL.
-     * 
+     *
      * @param url url of the input file
      * @throws IOException if an IO error occurs
      */
@@ -78,20 +78,20 @@
      * <strong>Preconditions:</strong><ul>
      * <li>the distribution must be loaded before invoking this method</li></ul>
      * @return the random value.
-     * 
+     *
      * @throws IllegalStateException if the distribution has not been loaded
      */
     double getNextValue() throws IllegalStateException;
 
 
     /**
-     * Returns a 
-     * {@link org.apache.commons.math.stat.descriptive.StatisticalSummary} 
+     * Returns a
+     * {@link org.apache.commons.math.stat.descriptive.StatisticalSummary}
      * describing this distribution.
      * <strong>Preconditions:</strong><ul>
      * <li>the distribution must be loaded before invoking this method</li>
      * </ul>
-     * 
+     *
      * @return the sample statistics
      * @throws IllegalStateException if the distribution has not been loaded
      */
@@ -99,24 +99,24 @@
 
     /**
      * Property indicating whether or not the distribution has been loaded.
-     * 
+     *
      * @return true if the distribution has been loaded
      */
     boolean isLoaded();
 
      /**
      * Returns the number of bins.
-     * 
+     *
      * @return the number of bins
      */
     int getBinCount();
 
     /**
-     * Returns a list of 
+     * Returns a list of
      * {@link org.apache.commons.math.stat.descriptive.SummaryStatistics}
      * containing statistics describing the values in each of the bins.  The
      * List is indexed on the bin number.
-     * 
+     *
      * @return List of bin statistics
      */
     List<SummaryStatistics> getBinStats();
@@ -125,7 +125,7 @@
      * Returns the array of upper bounds for the bins.  Bins are: <br/>
      * [min,upperBounds[0]],(upperBounds[0],upperBounds[1]],...,
      *  (upperBounds[binCount-1],max].
-     * 
+     *
      * @return array of bin upper bounds
      */
     double[] getUpperBounds();

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/EmpiricalDistributionImpl.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/EmpiricalDistributionImpl.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/EmpiricalDistributionImpl.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/EmpiricalDistributionImpl.java Sat Sep  5 17:36:48 2009
@@ -90,7 +90,7 @@
 
     /**
      * Creates a new EmpiricalDistribution  with the specified bin count.
-     * 
+     *
      * @param binCount number of bins
      */
     public EmpiricalDistributionImpl(int binCount) {
@@ -101,7 +101,7 @@
      /**
      * Computes the empirical distribution from the provided
      * array of numbers.
-     * 
+     *
      * @param in the input data array
      */
     public void load(double[] in) {
@@ -119,7 +119,7 @@
     /**
      * Computes the empirical distribution using data read from a URL.
      * @param url  url of the input file
-     * 
+     *
      * @throws IOException if an IO error occurs
      */
     public void load(URL url) throws IOException {
@@ -156,7 +156,7 @@
 
     /**
      * Computes the empirical distribution from the input file.
-     * 
+     *
      * @param file the input file
      * @throws IOException if an IO error occurs
      */
@@ -192,9 +192,9 @@
      * <code>beanStats</code> abstracting the source of data.
      */
     private abstract class DataAdapter{
-        /** 
+        /**
          * Compute bin stats.
-         * 
+         *
          * @param min minimum value
          * @param delta  grid size
          * @throws Exception  if an error occurs computing bin stats
@@ -203,7 +203,7 @@
                 throws Exception;
         /**
          * Compute sample statistics.
-         * 
+         *
          * @throws Exception if an error occurs computing sample stats
          */
         public abstract void computeStats() throws Exception;
@@ -216,7 +216,7 @@
     private class DataAdapterFactory{
         /**
          * Creates a DataAdapter from a data object
-         * 
+         *
          * @param in object providing access to the data
          * @return DataAdapter instance
          */
@@ -240,13 +240,13 @@
      * <code>DataAdapter</code> for data provided through some input stream
      */
     private class StreamDataAdapter extends DataAdapter{
-        
+
         /** Input stream providng access to the data */
         private BufferedReader inputStream;
-        
+
         /**
          * Create a StreamDataAdapter from a BufferedReader
-         * 
+         *
          * @param in BufferedReader input stream
          */
         public StreamDataAdapter(BufferedReader in){
@@ -255,7 +255,7 @@
         }
         /**
          * Computes binStats
-         * 
+         *
          * @param min  minimum value
          * @param delta  grid size
          * @throws IOException if an IO error occurs
@@ -276,7 +276,7 @@
         }
         /**
          * Computes sampleStats
-         * 
+         *
          * @throws IOException if an IOError occurs
          */
         @Override
@@ -297,13 +297,13 @@
      * <code>DataAdapter</code> for data provided as array of doubles.
      */
     private class ArrayDataAdapter extends DataAdapter{
-        
+
         /** Array of input  data values */
         private double[] inputArray;
-        
+
         /**
          * Construct an ArrayDataAdapter from a double[] array
-         * 
+         *
          * @param in double[] array holding the data
          */
         public ArrayDataAdapter(double[] in){
@@ -312,7 +312,7 @@
         }
         /**
          * Computes sampleStats
-         * 
+         *
          * @throws IOException if an IO error occurs
          */
         @Override
@@ -324,7 +324,7 @@
         }
         /**
          * Computes binStats
-         * 
+         *
          * @param min  minimum value
          * @param delta  grid size
          * @throws IOException  if an IO error occurs
@@ -342,7 +342,7 @@
 
     /**
      * Fills binStats array (second pass through data file).
-     * 
+     *
      * @param in object providing access to the data
      * @throws IOException  if an IO error occurs
      */
@@ -392,10 +392,10 @@
         }
         upperBounds[binCount-1] = 1.0d;
     }
-    
+
     /**
      * Returns the index of the bin to which the given value belongs
-     * 
+     *
      * @param min  the minimum value
      * @param value  the value whose bin we are trying to find
      * @param delta  the grid size
@@ -403,13 +403,13 @@
      */
     private int findBin(double min, double value, double delta) {
         return Math.min(
-                Math.max((int) Math.ceil((value- min) / delta) - 1, 0), 
+                Math.max((int) Math.ceil((value- min) / delta) - 1, 0),
                 binCount - 1);
         }
 
     /**
      * Generates a random value from this distribution.
-     * 
+     *
      * @return the random value.
      * @throws IllegalStateException if the distribution has not been loaded
      */
@@ -443,7 +443,7 @@
      * Returns a {@link StatisticalSummary} describing this distribution.
      * <strong>Preconditions:</strong><ul>
      * <li>the distribution must be loaded before invoking this method</li></ul>
-     * 
+     *
      * @return the sample statistics
      * @throws IllegalStateException if the distribution has not been loaded
      */
@@ -453,7 +453,7 @@
 
     /**
      * Returns the number of bins.
-     * 
+     *
      * @return the number of bins.
      */
     public int getBinCount() {
@@ -464,7 +464,7 @@
      * Returns a List of {@link SummaryStatistics} instances containing
      * statistics describing the values in each of the bins.  The list is
      * indexed on the bin number.
-     * 
+     *
      * @return List of bin statistics.
      */
     public List<SummaryStatistics> getBinStats() {
@@ -476,7 +476,7 @@
        Bins are: <br/>
      * [min,upperBounds[0]],(upperBounds[0],upperBounds[1]],...,
      *  (upperBounds[binCount-1],max]
-     * 
+     *
      * @return array of bin upper bounds
      */
     public double[] getUpperBounds() {
@@ -488,7 +488,7 @@
 
     /**
      * Property indicating whether or not the distribution has been loaded.
-     * 
+     *
      * @return true if the distribution has been loaded
      */
     public boolean isLoaded() {

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/GaussianRandomGenerator.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/GaussianRandomGenerator.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/GaussianRandomGenerator.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/GaussianRandomGenerator.java Sat Sep  5 17:36:48 2009
@@ -17,7 +17,7 @@
 
 package org.apache.commons.math.random;
 
-/** 
+/**
  * This class is a gaussian normalized random generator for scalars.
  * <p>This class is a simple wrapper around the {@link
  * RandomGenerator#nextGaussian} method.</p>

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/JDKRandomGenerator.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/JDKRandomGenerator.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/JDKRandomGenerator.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/JDKRandomGenerator.java Sat Sep  5 17:36:48 2009
@@ -19,7 +19,7 @@
 import java.util.Random;
 
 /**
- * Extension of <code>java.util.Random</code> to implement 
+ * Extension of <code>java.util.Random</code> to implement
  * {@link RandomGenerator}.
  *
  * @since 1.1

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/MersenneTwister.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/MersenneTwister.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/MersenneTwister.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/MersenneTwister.java Sat Sep  5 17:36:48 2009
@@ -53,8 +53,8 @@
  *   <li>Redistributions in binary form must reproduce the above copyright
  *       notice, this list of conditions and the following disclaimer in the
  *       documentation and/or other materials provided with the distribution.</li>
- *   <li>The names of its contributors may not be used to endorse or promote 
- *       products derived from this software without specific prior written 
+ *   <li>The names of its contributors may not be used to endorse or promote
+ *       products derived from this software without specific prior written
  *       permission.</li>
  * </ol></td></tr>
 
@@ -143,7 +143,7 @@
         for (mti = 1; mti < N; ++mti) {
             // See Knuth TAOCP Vol2. 3rd Ed. P.106 for multiplier.
             // initializer from the 2002-01-09 C version by Makoto Matsumoto
-            longMT = (1812433253l * (longMT ^ (longMT >> 30)) + mti) & 0xffffffffL; 
+            longMT = (1812433253l * (longMT ^ (longMT >> 30)) + mti) & 0xffffffffL;
             mt[mti]= (int) longMT;
         }
     }

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/NormalizedRandomGenerator.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/NormalizedRandomGenerator.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/NormalizedRandomGenerator.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/NormalizedRandomGenerator.java Sat Sep  5 17:36:48 2009
@@ -17,7 +17,7 @@
 
 package org.apache.commons.math.random;
 
-/** 
+/**
  * This interface represent a normalized random generator for
  * scalars.
  * Normalized generator provide null mean and unit standard deviation scalars.

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomAdaptor.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomAdaptor.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomAdaptor.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomAdaptor.java Sat Sep  5 17:36:48 2009
@@ -20,50 +20,50 @@
 
 /**
  * Extension of <code>java.util.Random</code> wrapping a
- * {@link RandomGenerator}.   
+ * {@link RandomGenerator}.
  *
  * @since 1.1
  * @version $Revision$ $Date$
  */
 public class RandomAdaptor extends Random implements RandomGenerator {
-    
+
     /** Serializable version identifier. */
     private static final long serialVersionUID = 2306581345647615033L;
 
     /** Wrapped randomGenerator instance */
     private RandomGenerator randomGenerator = null;
 
-    /** 
+    /**
      * Prevent instantiation without a generator argument
-     */ 
+     */
     @SuppressWarnings("unused")
     private RandomAdaptor() { }
-    
+
     /**
      * Construct a RandomAdaptor wrapping the supplied RandomGenerator.
-     * 
+     *
      * @param randomGenerator  the wrapped generator
      */
     public RandomAdaptor(RandomGenerator randomGenerator) {
         this.randomGenerator = randomGenerator;
-    } 
-    
+    }
+
     /**
      * Factory method to create a <code>Random</code> using the supplied
      * <code>RandomGenerator</code>.
-     * 
+     *
      * @param randomGenerator  wrapped RandomGenerator instance
      * @return a Random instance wrapping the RandomGenerator
      */
     public static Random createAdaptor(RandomGenerator randomGenerator) {
         return new RandomAdaptor(randomGenerator);
     }
-    
+
     /**
      * Returns the next pseudorandom, uniformly distributed
      * <code>boolean</code> value from this random number generator's
-     * sequence.  
-     * 
+     * sequence.
+     *
      * @return  the next pseudorandom, uniformly distributed
      * <code>boolean</code> value from this random number generator's
      * sequence
@@ -74,11 +74,11 @@
     }
 
      /**
-     * Generates random bytes and places them into a user-supplied 
-     * byte array.  The number of random bytes produced is equal to 
+     * Generates random bytes and places them into a user-supplied
+     * byte array.  The number of random bytes produced is equal to
      * the length of the byte array.
-     * 
-     * @param bytes the non-null byte array in which to put the 
+     *
+     * @param bytes the non-null byte array in which to put the
      * random bytes
      */
     @Override
@@ -87,14 +87,14 @@
     }
 
      /**
-     * Returns the next pseudorandom, uniformly distributed 
+     * Returns the next pseudorandom, uniformly distributed
      * <code>double</code> value between <code>0.0</code> and
-     * <code>1.0</code> from this random number generator's sequence.  
+     * <code>1.0</code> from this random number generator's sequence.
      *
-     * @return  the next pseudorandom, uniformly distributed 
+     * @return  the next pseudorandom, uniformly distributed
      *  <code>double</code> value between <code>0.0</code> and
      *  <code>1.0</code> from this random number generator's sequence
-     */  
+     */
     @Override
     public double nextDouble() {
         return randomGenerator.nextDouble();
@@ -103,7 +103,7 @@
     /**
      * Returns the next pseudorandom, uniformly distributed <code>float</code>
      * value between <code>0.0</code> and <code>1.0</code> from this random
-     * number generator's sequence.  
+     * number generator's sequence.
      *
      * @return  the next pseudorandom, uniformly distributed <code>float</code>
      * value between <code>0.0</code> and <code>1.0</code> from this
@@ -118,7 +118,7 @@
      * Returns the next pseudorandom, Gaussian ("normally") distributed
      * <code>double</code> value with mean <code>0.0</code> and standard
      * deviation <code>1.0</code> from this random number generator's sequence.
-     * 
+     *
      * @return  the next pseudorandom, Gaussian ("normally") distributed
      * <code>double</code> value with mean <code>0.0</code> and
      * standard deviation <code>1.0</code> from this random number
@@ -131,9 +131,9 @@
 
      /**
      * Returns the next pseudorandom, uniformly distributed <code>int</code>
-     * value from this random number generator's sequence.  
+     * value from this random number generator's sequence.
      * All 2<font size="-1"><sup>32</sup></font> possible <tt>int</tt> values
-     * should be produced with  (approximately) equal probability. 
+     * should be produced with  (approximately) equal probability.
      *
      * @return the next pseudorandom, uniformly distributed <code>int</code>
      *  value from this random number generator's sequence
@@ -146,7 +146,7 @@
     /**
      * Returns a pseudorandom, uniformly distributed <tt>int</tt> value
      * between 0 (inclusive) and the specified value (exclusive), drawn from
-     * this random number generator's sequence.   
+     * this random number generator's sequence.
      *
      * @param n the bound on the random number to be returned.  Must be
      * positive.
@@ -161,9 +161,9 @@
 
     /**
      * Returns the next pseudorandom, uniformly distributed <code>long</code>
-     * value from this random number generator's sequence.  All 
-     * 2<font size="-1"><sup>64</sup></font> possible <tt>long</tt> values 
-     * should be produced with (approximately) equal probability. 
+     * value from this random number generator's sequence.  All
+     * 2<font size="-1"><sup>64</sup></font> possible <tt>long</tt> values
+     * should be produced with (approximately) equal probability.
      *
      * @return  the next pseudorandom, uniformly distributed <code>long</code>
      *value from this random number generator's sequence

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomDataImpl.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomDataImpl.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomDataImpl.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomDataImpl.java Sat Sep  5 17:36:48 2009
@@ -81,7 +81,7 @@
  * This implementation is not synchronized.
  * </ul>
  * </p>
- * 
+ *
  * @version $Revision$ $Date$
  */
 public class RandomDataImpl implements RandomData, Serializable {
@@ -104,7 +104,7 @@
     /**
      * Construct a RandomDataImpl using the supplied {@link RandomGenerator} as
      * the source of (non-secure) random data.
-     * 
+     *
      * @param rand
      *            the source of (non-secure) random data
      * @since 1.1
@@ -126,7 +126,7 @@
      * Each binary byte is translated into 2 hex digits</li>
      * </ol>
      * </p>
-     * 
+     *
      * @param len
      *            the desired string length.
      * @return the random string.
@@ -170,7 +170,7 @@
     /**
      * Generate a random int value uniformly distributed between
      * <code>lower</code> and <code>upper</code>, inclusive.
-     * 
+     *
      * @param lower
      *            the lower bound.
      * @param upper
@@ -190,7 +190,7 @@
     /**
      * Generate a random long value uniformly distributed between
      * <code>lower</code> and <code>upper</code>, inclusive.
-     * 
+     *
      * @param lower
      *            the lower bound.
      * @param upper
@@ -222,7 +222,7 @@
      * Each byte of the binary digest is converted to 2 hex digits.</li>
      * </ol>
      * </p>
-     * 
+     *
      * @param len
      *            the length of the generated string
      * @return the random string
@@ -281,7 +281,7 @@
      * Generate a random int value uniformly distributed between
      * <code>lower</code> and <code>upper</code>, inclusive. This algorithm uses
      * a secure random number generator.
-     * 
+     *
      * @param lower
      *            the lower bound.
      * @param upper
@@ -302,7 +302,7 @@
      * Generate a random long value uniformly distributed between
      * <code>lower</code> and <code>upper</code>, inclusive. This algorithm uses
      * a secure random number generator.
-     * 
+     *
      * @param lower
      *            the lower bound.
      * @param upper
@@ -329,13 +329,13 @@
      * <p>
      * The Poisson process (and hence value returned) is bounded by 1000 * mean.
      * </p>
-     * 
+     *
      * <p>
      * For large means, uses a reject method as described in <a
      * href="http://cg.scs.carleton.ca/~luc/rnbookindex.html">Non-Uniform Random
      * Variate Generation</a>
      * </p>
-     * 
+     *
      * <p>
      * References:
      * <ul>
@@ -343,7 +343,7 @@
      * New York, NY. Springer-Verlag</li>
      * </ul>
      * </p>
-     * 
+     *
      * @param mean
      *            mean of the Poisson distribution.
      * @return the random Poisson value.
@@ -444,7 +444,7 @@
      * Generate a random value from a Normal (a.k.a. Gaussian) distribution with
      * the given mean, <code>mu</code> and the given standard deviation,
      * <code>sigma</code>.
-     * 
+     *
      * @param mu
      *            the mean of the distribution
      * @param sigma
@@ -468,7 +468,7 @@
      * Method</a> to generate exponentially distributed random values from
      * uniform deviates.
      * </p>
-     * 
+     *
      * @param mean
      *            the mean of the distribution
      * @return the random Exponential value
@@ -494,7 +494,7 @@
      * random double if Random.nextDouble() returns 0). This is necessary to
      * provide a symmetric output interval (both endpoints excluded).
      * </p>
-     * 
+     *
      * @param lower
      *            the lower bound.
      * @param upper
@@ -524,7 +524,7 @@
      * <p>
      * Creates and initializes a default generator if null.
      * </p>
-     * 
+     *
      * @return the Random used to generate random data
      * @since 1.1
      */
@@ -541,7 +541,7 @@
      * <p>
      * Creates and initializes if null.
      * </p>
-     * 
+     *
      * @return the SecureRandom used to generate secure random data
      */
     private SecureRandom getSecRan() {
@@ -557,7 +557,7 @@
      * <p>
      * Will create and initialize if null.
      * </p>
-     * 
+     *
      * @param seed
      *            the seed value to use
      */
@@ -587,7 +587,7 @@
      * <p>
      * Will create and initialize if null.
      * </p>
-     * 
+     *
      * @param seed
      *            the seed value to use
      */
@@ -619,7 +619,7 @@
      * <strong>USAGE NOTE:</strong> This method carries <i>significant</i>
      * overhead and may take several seconds to execute.
      * </p>
-     * 
+     *
      * @param algorithm
      *            the name of the PRNG algorithm
      * @param provider
@@ -655,7 +655,7 @@
      * href="http://www.maths.abdn.ac.uk/~igc/tch/mx4002/notes/node83.html">
      * here</a>.
      * </p>
-     * 
+     *
      * @param n
      *            domain of the permutation (must be positive)
      * @param k
@@ -691,7 +691,7 @@
      * generate random samples, <a
      * href="http://www.maths.abdn.ac.uk/~igc/tch/mx4002/notes/node83.html">
      * here</a>
-     * 
+     *
      * @param c
      *            Collection to sample from.
      * @param k
@@ -723,7 +723,7 @@
     /**
      * Uses a 2-cycle permutation shuffle to randomly re-order the last elements
      * of list.
-     * 
+     *
      * @param list
      *            list to be shuffled
      * @param end
@@ -745,7 +745,7 @@
 
     /**
      * Returns an array representing n.
-     * 
+     *
      * @param n
      *            the natural number to represent
      * @return array with entries = elements of n

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomGenerator.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomGenerator.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomGenerator.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomGenerator.java Sat Sep  5 17:36:48 2009
@@ -19,13 +19,13 @@
 
 /**
  * Interface extracted from <code>java.util.Random</code>.  This interface is
- * implemented by {@link AbstractRandomGenerator}.  
+ * implemented by {@link AbstractRandomGenerator}.
  *
  * @since 1.1
  * @version $Revision$ $Date$
  */
 public interface RandomGenerator {
-    
+
     /**
      * Sets the seed of the underyling random number generator using an
      * <code>int</code> seed.
@@ -45,7 +45,7 @@
      * @param seed the seed value
      */
     void setSeed(int[] seed);
-    
+
     /**
      * Sets the seed of the underyling random number generator using a
      * <code>long</code> seed.
@@ -55,32 +55,32 @@
      * @param seed the seed value
      */
     void setSeed(long seed);
-    
+
     /**
-     * Generates random bytes and places them into a user-supplied 
-     * byte array.  The number of random bytes produced is equal to 
+     * Generates random bytes and places them into a user-supplied
+     * byte array.  The number of random bytes produced is equal to
      * the length of the byte array.
-     * 
-     * @param bytes the non-null byte array in which to put the 
+     *
+     * @param bytes the non-null byte array in which to put the
      * random bytes
      */
     void nextBytes(byte[] bytes);
-    
+
     /**
      * Returns the next pseudorandom, uniformly distributed <code>int</code>
-     * value from this random number generator's sequence.  
+     * value from this random number generator's sequence.
      * All 2<font size="-1"><sup>32</sup></font> possible <tt>int</tt> values
-     * should be produced with  (approximately) equal probability. 
+     * should be produced with  (approximately) equal probability.
      *
      * @return the next pseudorandom, uniformly distributed <code>int</code>
      *  value from this random number generator's sequence
      */
     int nextInt();
-    
+
     /**
      * Returns a pseudorandom, uniformly distributed <tt>int</tt> value
      * between 0 (inclusive) and the specified value (exclusive), drawn from
-     * this random number generator's sequence.   
+     * this random number generator's sequence.
      *
      * @param n the bound on the random number to be returned.  Must be
      * positive.
@@ -89,56 +89,56 @@
      * @throws IllegalArgumentException  if n is not positive.
      */
     int nextInt(int n);
-    
+
     /**
      * Returns the next pseudorandom, uniformly distributed <code>long</code>
-     * value from this random number generator's sequence.  All 
-     * 2<font size="-1"><sup>64</sup></font> possible <tt>long</tt> values 
-     * should be produced with (approximately) equal probability. 
+     * value from this random number generator's sequence.  All
+     * 2<font size="-1"><sup>64</sup></font> possible <tt>long</tt> values
+     * should be produced with (approximately) equal probability.
      *
      * @return  the next pseudorandom, uniformly distributed <code>long</code>
      *value from this random number generator's sequence
      */
     long nextLong();
-    
+
     /**
      * Returns the next pseudorandom, uniformly distributed
      * <code>boolean</code> value from this random number generator's
-     * sequence.  
-     * 
+     * sequence.
+     *
      * @return  the next pseudorandom, uniformly distributed
      * <code>boolean</code> value from this random number generator's
      * sequence
      */
     boolean nextBoolean();
-    
+
     /**
      * Returns the next pseudorandom, uniformly distributed <code>float</code>
      * value between <code>0.0</code> and <code>1.0</code> from this random
-     * number generator's sequence.  
+     * number generator's sequence.
      *
      * @return  the next pseudorandom, uniformly distributed <code>float</code>
      * value between <code>0.0</code> and <code>1.0</code> from this
      * random number generator's sequence
      */
     float nextFloat();
-    
+
     /**
-     * Returns the next pseudorandom, uniformly distributed 
+     * Returns the next pseudorandom, uniformly distributed
      * <code>double</code> value between <code>0.0</code> and
-     * <code>1.0</code> from this random number generator's sequence.  
+     * <code>1.0</code> from this random number generator's sequence.
      *
-     * @return  the next pseudorandom, uniformly distributed 
+     * @return  the next pseudorandom, uniformly distributed
      *  <code>double</code> value between <code>0.0</code> and
      *  <code>1.0</code> from this random number generator's sequence
-     */  
+     */
     double nextDouble();
-    
+
     /**
      * Returns the next pseudorandom, Gaussian ("normally") distributed
      * <code>double</code> value with mean <code>0.0</code> and standard
      * deviation <code>1.0</code> from this random number generator's sequence.
-     * 
+     *
      * @return  the next pseudorandom, Gaussian ("normally") distributed
      * <code>double</code> value with mean <code>0.0</code> and
      * standard deviation <code>1.0</code> from this random number

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomVectorGenerator.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomVectorGenerator.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomVectorGenerator.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/RandomVectorGenerator.java Sat Sep  5 17:36:48 2009
@@ -19,7 +19,7 @@
 
 
 /** This interface represents a random generator for whole vectors.
- * 
+ *
  * @since 1.2
  * @version $Revision$ $Date$
  *

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/UncorrelatedRandomVectorGenerator.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/UncorrelatedRandomVectorGenerator.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/UncorrelatedRandomVectorGenerator.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/UncorrelatedRandomVectorGenerator.java Sat Sep  5 17:36:48 2009
@@ -21,11 +21,11 @@
 
 import org.apache.commons.math.MathRuntimeException;
 
-/** 
+/**
  * A {@link RandomVectorGenerator} that generates vectors with uncorrelated
  * components. Components of generated vectors follow (independent) Gaussian
  * distributions, with parameters supplied in the constructor.
- * 
+ *
  * @version $Revision$ $Date$
  * @since 1.2
  */
@@ -74,7 +74,7 @@
    */
   public double[] nextVector() {
 
-    double[] random = new double[mean.length]; 
+    double[] random = new double[mean.length];
     for (int i = 0; i < random.length; ++i) {
       random[i] = mean[i] + standardDeviation[i] * generator.nextNormalizedDouble();
     }

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/UniformRandomGenerator.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/UniformRandomGenerator.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/UniformRandomGenerator.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/UniformRandomGenerator.java Sat Sep  5 17:36:48 2009
@@ -17,15 +17,15 @@
 
 package org.apache.commons.math.random;
 
-/** 
+/**
  * This class implements a normalized uniform random generator.
  * <p>Since it is a normalized random generator, it generates values
- * from a uniform distribution with mean equal to 0 and standard 
+ * from a uniform distribution with mean equal to 0 and standard
  * deviation equal to 1. Generated values fall in the range
  * [-&#x0221A;3, +&#x0221A;3].</p>
- * 
+ *
  * @since 1.2
- * 
+ *
  * @version $Revision$ $Date$
  */
 

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/ValueServer.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/ValueServer.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/ValueServer.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/random/ValueServer.java Sat Sep  5 17:36:48 2009
@@ -372,7 +372,7 @@
     /**
      * Construct a ValueServer instance using a RandomData as its source
      * of random data.
-     * 
+     *
      * @param randomData the RandomData instance used to source random data
      * @since 1.1
      */

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/special/Beta.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/special/Beta.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/special/Beta.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/special/Beta.java Sat Sep  5 17:36:48 2009
@@ -41,7 +41,7 @@
      * Returns the
      * <a href="http://mathworld.wolfram.com/RegularizedBetaFunction.html">
      * regularized beta function</a> I(x, a, b).
-     * 
+     *
      * @param x the value.
      * @param a the a parameter.
      * @param b the b parameter.
@@ -58,7 +58,7 @@
      * Returns the
      * <a href="http://mathworld.wolfram.com/RegularizedBetaFunction.html">
      * regularized beta function</a> I(x, a, b).
-     * 
+     *
      * @param x the value.
      * @param a the a parameter.
      * @param b the b parameter.
@@ -76,11 +76,11 @@
 
     /**
      * Returns the regularized beta function I(x, a, b).
-     * 
+     *
      * @param x the value.
      * @param a the a parameter.
      * @param b the b parameter.
-     * @param maxIterations Maximum number of "iterations" to complete. 
+     * @param maxIterations Maximum number of "iterations" to complete.
      * @return the regularized beta function I(x, a, b)
      * @throws MathException if the algorithm fails to converge.
      */
@@ -89,10 +89,10 @@
     {
         return regularizedBeta(x, a, b, DEFAULT_EPSILON, maxIterations);
     }
-    
+
     /**
      * Returns the regularized beta function I(x, a, b).
-     * 
+     *
      * The implementation of this method is based on:
      * <ul>
      * <li>
@@ -102,14 +102,14 @@
      * <a href="http://functions.wolfram.com/06.21.10.0001.01">
      * Regularized Beta Function</a>.</li>
      * </ul>
-     * 
+     *
      * @param x the value.
      * @param a the a parameter.
      * @param b the b parameter.
      * @param epsilon When the absolute value of the nth item in the
      *                series is less than epsilon the approximation ceases
      *                to calculate further elements in the series.
-     * @param maxIterations Maximum number of "iterations" to complete. 
+     * @param maxIterations Maximum number of "iterations" to complete.
      * @return the regularized beta function I(x, a, b)
      * @throws MathException if the algorithm fails to converge.
      */
@@ -158,7 +158,7 @@
 
     /**
      * Returns the natural logarithm of the beta function B(a, b).
-     * 
+     *
      * @param a the a parameter.
      * @param b the b parameter.
      * @return log(B(a, b))
@@ -166,7 +166,7 @@
     public static double logBeta(double a, double b) {
         return logBeta(a, b, DEFAULT_EPSILON, Integer.MAX_VALUE);
     }
-    
+
     /**
      * Returns the natural logarithm of the beta function B(a, b).
      *
@@ -175,18 +175,18 @@
      * <li><a href="http://mathworld.wolfram.com/BetaFunction.html">
      * Beta Function</a>, equation (1).</li>
      * </ul>
-     * 
+     *
      * @param a the a parameter.
      * @param b the b parameter.
      * @param epsilon When the absolute value of the nth item in the
      *                series is less than epsilon the approximation ceases
      *                to calculate further elements in the series.
-     * @param maxIterations Maximum number of "iterations" to complete. 
+     * @param maxIterations Maximum number of "iterations" to complete.
      * @return log(B(a, b))
      */
     public static double logBeta(double a, double b, double epsilon,
         int maxIterations) {
-            
+
         double ret;
 
         if (Double.isNaN(a) || Double.isNaN(b) || (a <= 0.0) || (b <= 0.0)) {

Modified: commons/proper/math/trunk/src/main/java/org/apache/commons/math/special/Erf.java
URL: http://svn.apache.org/viewvc/commons/proper/math/trunk/src/main/java/org/apache/commons/math/special/Erf.java?rev=811685&r1=811684&r2=811685&view=diff
==============================================================================
--- commons/proper/math/trunk/src/main/java/org/apache/commons/math/special/Erf.java (original)
+++ commons/proper/math/trunk/src/main/java/org/apache/commons/math/special/Erf.java Sat Sep  5 17:36:48 2009
@@ -35,14 +35,14 @@
 
     /**
      * Returns the error function erf(x).
-     * 
+     *
      * The implementation of this method is based on:
      * <ul>
      * <li>
      * <a href="http://mathworld.wolfram.com/Erf.html">
      * Erf</a>, equation (3).</li>
      * </ul>
-     * 
+     *
      * @param x the value.
      * @return the error function erf(x)
      * @throws MathException if the algorithm fails to converge.