zoukankan      html  css  js  c++  java
  • Mahout 系列之----共轭梯度

     

    无预处理共轭梯度

    要求解线性方程组 oldsymbol{Ax}=oldsymbol{b},稳定双共轭梯度法从初始解 oldsymbol{x}_0 开始按以下步骤迭代:

    1. oldsymbol{r}_0=oldsymbol{b}-oldsymbol{Ax}
    2. 任意选择向量 oldsymbol{hat{r}}_0; 使得 (oldsymbol{hat{r}}_0,oldsymbol{r}_0) 
eq0;,例如,oldsymbol{hat{r}}_0=oldsymbol{r}_0;
    3. 
ho_0=alpha=omega_0=1;
    4. oldsymbol{v}_0=oldsymbol{p}_0=oldsymbol{0}
    5. i=1,2,3,ldots
      1. 
ho_i=(oldsymbol{hat{r}}_0,oldsymbol{r}_{i-1});
      2. eta=(
ho_i/
ho_{i-1})(alpha/omega_{i-1});
      3. oldsymbol{p}_i=oldsymbol{r}_{i-1}+eta(oldsymbol{p}_{i-1}-omega_{i-1}oldsymbol{v}_{i-1})
      4. oldsymbol{v}_i=oldsymbol{Ap}_i
      5. alpha=
ho_i/(oldsymbol{hat{r}}_0,oldsymbol{v}_i);
      6. oldsymbol{s}=oldsymbol{r}_{i-1}-alphaoldsymbol{v}_i
      7. oldsymbol{t}=oldsymbol{As}
      8. omega_i=(oldsymbol{t},oldsymbol{s})/(oldsymbol{t},oldsymbol{t})
      9. oldsymbol{x}_i=oldsymbol{x}_{i-1}+alphaoldsymbol{p}_i+omega_ioldsymbol{s}
      10. oldsymbol{x}_i 足够精确则退出
      11. oldsymbol{r}_i=oldsymbol{s}-omega_ioldsymbol{t}

    预处理共轭梯度

    预处理通常被用来加速迭代方法的收敛。要使用预处理子 oldsymbol{K}=oldsymbol{K}_1oldsymbol{K}_2approxoldsymbol{A} 来求解线性方程组 oldsymbol{Ax}=oldsymbol{b},预处理稳定双共轭梯度法从初始解 oldsymbol{x}_0 开始按以下步骤迭代:

    1. oldsymbol{r}_0=oldsymbol{b}-oldsymbol{Ax}
    2. 任意选择向量 oldsymbol{hat{r}}_0; 使得 (oldsymbol{hat{r}}_0,oldsymbol{r}_0) 
eq0;,例如,oldsymbol{hat{r}}_0=oldsymbol{r}_0;
    3. 
ho_0=alpha=omega_0=1;
    4. oldsymbol{v}_0=oldsymbol{p}_0=oldsymbol{0}
    5. i=1,2,3,ldots
      1. 
ho_i=(oldsymbol{hat{r}}_0,oldsymbol{r}_{i-1});
      2. eta=(
ho_i/
ho_{i-1})(alpha/omega_{i-1});
      3. oldsymbol{p}_i=oldsymbol{r}_{i-1}+eta(oldsymbol{p}_{i-1}-omega_{i-1}oldsymbol{v}_{i-1})
      4. oldsymbol{y}=oldsymbol{K}^{-1}oldsymbol{p}_i
      5. oldsymbol{v}_i=oldsymbol{Ay}
      6. alpha=
ho_i/(oldsymbol{hat{r}}_0,oldsymbol{v}_i);
      7. oldsymbol{s}=oldsymbol{r}_i-alphaoldsymbol{v}_i
      8. oldsymbol{z}=oldsymbol{As}
      9. oldsymbol{t}=oldsymbol{K}^{-1}oldsymbol{z}
      10. omega_i=(oldsymbol{K}_1^{-1}oldsymbol{t},oldsymbol{K}_1^{-1}oldsymbol{s})/(oldsymbol{K}_1^{-1}oldsymbol{s},oldsymbol{K}_1^{-1}oldsymbol{s})
      11. oldsymbol{x}_i=oldsymbol{x}_{i-1}+alphaoldsymbol{y}+omega_ioldsymbol{z}
      12. oldsymbol{x}_i 足够精确则退出
      13. oldsymbol{r}_i=oldsymbol{s}-omega_ioldsymbol{t}

    这个形式等价于将无预处理的稳定双共轭梯度法应用于显式预处理后的方程组

    oldsymbol{	ilde{A}	ilde{x}}=oldsymbol{	ilde{b}}

    其中 oldsymbol{	ilde{A}}=oldsymbol{K}_1^{-1}oldsymbol{AK}_2^{-1}oldsymbol{	ilde{x}}=oldsymbol{K}_2oldsymbol{x}oldsymbol{	ilde{b}}=oldsymbol{K}_1^{-1}oldsymbol{b}。换句话说,左预处理和右预处理都可以通过这个形式实施。

    Mahout 分布式共轭梯度实现:


    package org.apache.mahout.math.solver;

    import org.apache.mahout.math.CardinalityException;
    import org.apache.mahout.math.DenseVector;
    import org.apache.mahout.math.Vector;
    import org.apache.mahout.math.VectorIterable;
    import org.apache.mahout.math.function.Functions;
    import org.apache.mahout.math.function.PlusMult;
    import org.slf4j.Logger;
    import org.slf4j.LoggerFactory;

    /**
     * <p>Implementation of a conjugate gradient iterative solver for linear systems. Implements both
     * standard conjugate gradient and pre-conditioned conjugate gradient.
     *
     * <p>Conjugate gradient requires the matrix A in the linear system Ax = b to be symmetric and positive
     * definite. For convenience, this implementation allows the input matrix to be be non-symmetric, in
     * which case the system A'Ax = b is solved. Because this requires only one pass through the matrix A, it
     * is faster than explictly computing A'A, then passing the results to the solver.
     *
     * <p>For inputs that may be ill conditioned (often the case for highly sparse input), this solver
     * also accepts a parameter, lambda, which adds a scaled identity to the matrix A, solving the system
     * (A + lambda*I)x = b. This obviously changes the solution, but it will guarantee solvability. The
     * ridge regression approach to linear regression is a common use of this feature.
     *
     * <p>If only an approximate solution is required, the maximum number of iterations or the error threshold
     * may be specified to end the algorithm early at the expense of accuracy. When the matrix A is ill conditioned,
     * it may sometimes be necessary to increase the maximum number of iterations above the default of A.numCols()
     * due to numerical issues.
     *
     * <p>By default the solver will run a.numCols() iterations or until the residual falls below 1E-9.
     *
     * <p>For more information on the conjugate gradient algorithm, see Golub & van Loan, "Matrix Computations",
     * sections 10.2 and 10.3 or the <a href="http://en.wikipedia.org/wiki/Conjugate_gradient">conjugate gradient
     * wikipedia article</a>.
     */

    public class ConjugateGradientSolver {

      public static final double DEFAULT_MAX_ERROR = 1.0e-9;
     
      private static final Logger log = LoggerFactory.getLogger(ConjugateGradientSolver.class);
      private static final PlusMult PLUS_MULT = new PlusMult(1.0);

      private int iterations;
      private double residualNormSquared;
     
      public ConjugateGradientSolver() {
        this.iterations = 0;
        this.residualNormSquared = Double.NaN;
      } 

      /**
       * Solves the system Ax = b with default termination criteria. A must be symmetric, square, and positive definite.
       * Only the squareness of a is checked, since testing for symmetry and positive definiteness are too expensive. If
       * an invalid matrix is specified, then the algorithm may not yield a valid result.
       * 
       * @param a  The linear operator A.
       * @param b  The vector b.
       * @return The result x of solving the system.
       * @throws IllegalArgumentException if a is not square or if the size of b is not equal to the number of columns of a.
       *
       */
      public Vector solve(VectorIterable a, Vector b) {
        return solve(a, b, null, b.size(), DEFAULT_MAX_ERROR);
      }
     
      /**
       * Solves the system Ax = b with default termination criteria using the specified preconditioner. A must be
       * symmetric, square, and positive definite. Only the squareness of a is checked, since testing for symmetry
       * and positive definiteness are too expensive. If an invalid matrix is specified, then the algorithm may not
       * yield a valid result.
       * 
       * @param a  The linear operator A.
       * @param b  The vector b.
       * @param precond A preconditioner to use on A during the solution process.
       * @return The result x of solving the system.
       * @throws IllegalArgumentException if a is not square or if the size of b is not equal to the number of columns of a.
       *
       */
      public Vector solve(VectorIterable a, Vector b, Preconditioner precond) {
        return solve(a, b, precond, b.size(), DEFAULT_MAX_ERROR);
      }
     

      /**
       * Solves the system Ax = b, where A is a linear operator and b is a vector. Uses the specified preconditioner
       * to improve numeric stability and possibly speed convergence. This version of solve() allows control over the
       * termination and iteration parameters.
       *
       * @param a  The matrix A.
       * @param b  The vector b.
       * @param preconditioner The preconditioner to apply.
       * @param maxIterations The maximum number of iterations to run.
       * @param maxError The maximum amount of residual error to tolerate. The algorithm will run until the residual falls
       * below this value or until maxIterations are completed.
       * @return The result x of solving the system.
       * @throws IllegalArgumentException if the matrix is not square, if the size of b is not equal to the number of
       * columns of A, if maxError is less than zero, or if maxIterations is not positive.
       */
      

    // 共轭梯度实现的主题部分。很明显该方法是既可以用预处理的方式,也可以不用预处理的方式。Mahout中提供了单机模式的雅克比预处理,但是没有提供分布式处理的雅克比预处理,这个需要自己写。很简单,只要将对角线元素去倒数,组成一个对角阵即可。
      public Vector solve(VectorIterable a,
                          Vector b,
                          Preconditioner preconditioner,
                          int maxIterations,
                          double maxError) {

        if (a.numRows() != a.numCols()) {
          throw new IllegalArgumentException("Matrix must be square, symmetric and positive definite.");
        }
       
        if (a.numCols() != b.size()) {
          throw new CardinalityException(a.numCols(), b.size());
        }

        if (maxIterations <= 0) {
          throw new IllegalArgumentException("Max iterations must be positive.");     
        }
       
        if (maxError < 0.0) {
          throw new IllegalArgumentException("Max error must be non-negative.");
        }
       
        Vector x = new DenseVector(b.size());

        iterations = 0;
        Vector residual = b.minus(a.times(x));
        residualNormSquared = residual.dot(residual);

        log.info("Conjugate gradient initial residual norm = {}", Math.sqrt(residualNormSquared));
        double previousConditionedNormSqr = 0.0;
        Vector updateDirection = null;
        while (Math.sqrt(residualNormSquared) > maxError && iterations < maxIterations) {
          Vector conditionedResidual;
          double conditionedNormSqr;
          if (preconditioner == null) {
            conditionedResidual = residual;
            conditionedNormSqr = residualNormSquared;
          } else {
            conditionedResidual = preconditioner.precondition(residual);
            conditionedNormSqr = residual.dot(conditionedResidual);
          }     
         
          ++iterations;
         
          if (iterations == 1) {
            updateDirection = new DenseVector(conditionedResidual);
          } else {
            double beta = conditionedNormSqr / previousConditionedNormSqr;
           
            // updateDirection = residual + beta * updateDirection
            updateDirection.assign(Functions.MULT, beta);
            updateDirection.assign(conditionedResidual, Functions.PLUS);
          }
         
          Vector aTimesUpdate = a.times(updateDirection);
         
          double alpha = conditionedNormSqr / updateDirection.dot(aTimesUpdate);
         
          // x = x + alpha * updateDirection
          PLUS_MULT.setMultiplicator(alpha);
          x.assign(updateDirection, PLUS_MULT);

          // residual = residual - alpha * A * updateDirection
          PLUS_MULT.setMultiplicator(-alpha);
          residual.assign(aTimesUpdate, PLUS_MULT);
         
          previousConditionedNormSqr = conditionedNormSqr;
          residualNormSquared = residual.dot(residual);
         
          log.info("Conjugate gradient iteration {} residual norm = {}", iterations, Math.sqrt(residualNormSquared));
        }
        return x;
      }

      /**
       * Returns the number of iterations run once the solver is complete.
       *
       * @return The number of iterations run.
       */
      public int getIterations() {
        return iterations;
      }

      /**
       * Returns the norm of the residual at the completion of the solver. Usually this should be close to zero except in
       * the case of a non positive definite matrix A, which results in an unsolvable system, or for ill conditioned A, in
       * which case more iterations than the default may be needed.
       *
       * @return The norm of the residual in the solution.
       */
      public double getResidualNorm() {
        return Math.sqrt(residualNormSquared);
      } 
    }

    DistributedConjugateGradientSolver  是上CG的扩展,DCG和CG的区别在于,DCG矩阵和向量相乘时需要MR实现矩阵相乘。
  • 相关阅读:
    web.py的input获取问题
    python unicode和 utf8字符串比较
    python default encoding
    linux flash player的问题
    centos 支持 ntfs格式
    学习jqueryjquery中的show()和hide()
    字符串等长分割
    类加载器分类
    类加载器子系统
    70道HR的面试题
  • 原文地址:https://www.cnblogs.com/cl1024cl/p/6205319.html
Copyright © 2011-2022 走看看