Algorithm 查找二维点云的内圈/椭圆

Algorithm 查找二维点云的内圈/椭圆,algorithm,geometry,computational-geometry,point,point-clouds,Algorithm,Geometry,Computational Geometry,Point,Point Clouds,我有一堆二维点。你可以在左图上看到它们。它们形成一个有几只兔子耳朵的戒指。我的目标是找到大的内循环/椭圆,你可以在右边看到 什么样的算法对这种情况有用 我尝试了RANSAC算法的一种变体(随机抽取5个点,形成一个椭圆,确定一个分数,然后重复)。我在某种程度上设计了评分函数,椭圆内的点会得到很多负值,而椭圆外的点会得到很多正值。 但结果一点也不乐观。算法找到了环,但是我得到了环的一些随机椭圆,而不是我想要的大的内椭圆 有什么好的策略吗?下面是一些用于最佳拟合圈的Java代码 //版权所有(c

我有一堆二维点。你可以在左图上看到它们。它们形成一个有几只兔子耳朵的戒指。我的目标是找到大的内循环/椭圆,你可以在右边看到

什么样的算法对这种情况有用

我尝试了RANSAC算法的一种变体(随机抽取5个点,形成一个椭圆,确定一个分数,然后重复)。我在某种程度上设计了评分函数,椭圆内的点会得到很多负值,而椭圆外的点会得到很多正值。 但结果一点也不乐观。算法找到了环,但是我得到了环的一些随机椭圆,而不是我想要的大的内椭圆


有什么好的策略吗?

下面是一些用于最佳拟合圈的Java代码

//版权所有(c)2005-2007,Luc Maisonobe
//版权所有。
// 
//以源代码和二进制形式重新分发和使用
//或未经修改,但前提是
//满足以下条件:
// 
//源代码的重新分发必须保留
//上述版权声明、本条件清单和
//以下是免责声明。
//二进制形式的重新分配必须复制
//上述版权声明、本条件清单和
//文档中的以下免责声明
//和/或随附的其他材料
//分配。
//spaceroots.org和spaceroots.com的名称
//他们的贡献者的名字也不能用来解释
//认可或推广由此衍生的产品
//未经事先书面许可的软件。
// 
//本软件由版权所有人和
//“按原样”投稿人以及任何明示或暗示的投稿人
//保证,包括但不限于暗示的
//对产品适销性和适用性的保证
//特殊用途不作声明。在任何情况下均不得
//版权所有人或贡献者对任何
//直接、间接、附带、特殊、示范或
//间接损害(包括但不限于:,
//采购替代货物或服务;损失
//使用、数据或利润;或业务中断)
//无论是何种原因造成的,且基于任何责任理论
//在合同中,严格责任或侵权行为(包括
//疏忽或其他)以任何方式产生的
//使用本软件,即使已告知
//这种损害的可能性。
包org.oots;
导入java.io.Reader;
导入java.io.BufferedReader;
导入java.io.InputStreamReader;
导入java.io.FileReader;
导入java.io.IOException;
导入java.util.ArrayList;
导入java.util.Iterator;
导入java.util.Locale;
导入java.text.DecimalFormat;
导入java.text.DecimalFormatSymbols;
导入java.awt.geom.Point2D;
/**类将圆拟合到一组点。
*此类实现中描述的拟合算法
*纸

*@作者Luc Maisonobe */ 公共类电路板{ /**测试程序入口点。 *@param args命令行参数 */ 公共静态void main(字符串[]args){ 试一试{ BufferedReader br=null; 开关(参数长度){ 案例0: br=新的BufferedReader((新的InputStreamReader(System.in)); 打破 案例1: br=新的BufferedReader(新的文件读取器(args[0]); 打破 违约: System.err.println(“用法:javacirclefitter[file]”); 系统出口(1); } //阅读要点,忽略空行和注释行 ArrayList=新建ArrayList(); int l=0; 对于(字符串line=br.readLine();line!=null;line=br.readLine()){ ++l; line=line.trim(); 如果((line.length()>0)和((!line.startsWith(“#”)的话){ //这是一条数据线,我们需要两个数值字段 字符串[]字段=行。拆分(\\s+); 如果(fields.length!=2){ 抛出新的LocalException(“第“+l+”行出现语法错误):“+line +(应为两个字段,找到) +字段长度+”); } //解析字段并将点添加到列表中 添加(新点2d.Double(Double.parseDouble)(字段[0]), Double.parseDouble(字段[1]); } } 点2D。双[]点= (Point2D.Double[])list.toArray(新的Point2D.Double[list.size()]); 十进制格式= 新的十进制格式(“000.00000000”), 新的十进制符号(Locale.US)); //在测试点上画一个圆 CircleFitter fitter=新CircleFitter(); 装配工初始化(点); System.out.println(“初始圆:” +format.format(fitter.getCenter().x) +“”+format.format(fitter.getCenter().y) +“”+format.format(fitter.getRadius()); //最小化残差 int iter=装配工最小值(100,0.1,1.0e-12); System.out.println(“在“+iter+”迭代之后收敛”); System.out.println(“最终圆: +format.format(fitter.getCenter().x) +“”+format.format(fitter.getCenter().y) +“”+format.format(fitter.getRadius()); }捕获(ioe异常ioe){ System.err.println(ioe.getMessage()); 系统出口(1); }捕获(本地异常){ System.err.println(le.getMessage()); 系统出口(1); } } /**使用默认的当前圆构建新实例。 */ 公共循环基金(){ 中心=新点2D.Double(0.0,0.0); rHat=1.0; 点数=零; } /**基于所有三元组初始化一个近似圆。 *@param points环形采样点 *@exception LocalException如果
// Copyright (c) 2005-2007, Luc Maisonobe
// All rights reserved.
// 
// Redistribution and use in source and binary forms, with
// or without modification, are permitted provided that
// the following conditions are met:
// 
//    Redistributions of source code must retain the
//    above copyright notice, this list of conditions and
//    the following disclaimer. 
//    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. 
//    Neither the names of spaceroots.org, spaceroots.com
//    nor the names of their contributors may be used to
//    endorse or promote products derived from this
//    software without specific prior written permission. 
// 
// THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND
// CONTRIBUTORS "AS IS" AND ANY EXPRESS OR IMPLIED
// WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED
// WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A
// PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL
// THE COPYRIGHT OWNER OR CONTRIBUTORS BE LIABLE FOR ANY
// DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR
// CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO,
// PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF
// USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION)
// HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER
// IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING
// NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE
// USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE
// POSSIBILITY OF SUCH DAMAGE.

package org.spaceroots;

import java.io.Reader;
import java.io.BufferedReader;
import java.io.InputStreamReader;
import java.io.FileReader;
import java.io.IOException;
import java.util.ArrayList;
import java.util.Iterator;
import java.util.Locale;
import java.text.DecimalFormat;
import java.text.DecimalFormatSymbols;
import java.awt.geom.Point2D;

/** Class fitting a circle to a set of points.
 * <p>This class implements the fitting algorithms described in the
 * paper <a
 * href="http://www.spaceroots.org/documents/circle/circle-fitting.pdf">
 * Finding the circle that best fits a set of points</a></p>
 * @author Luc Maisonobe
 */
public class CircleFitter {

  /** Test program entry point.
   * @param args command line arguments
   */
  public static void main(String[] args) {
    try {

      BufferedReader br = null;
      switch (args.length) {
      case 0 :
        br = new BufferedReader((new InputStreamReader(System.in)));
        break;
      case 1:
        br = new BufferedReader(new FileReader(args[0]));
        break;
      default :
        System.err.println("usage: java CircleFitter [file]");
        System.exit(1);
      }

      // read the points, ignoring blank lines and comment lines
      ArrayList list = new ArrayList();
      int l = 0;
      for (String line = br.readLine(); line != null; line = br.readLine()) {
        ++l;
        line = line.trim();
        if ((line.length() > 0) && (! line.startsWith("#"))) {
          // this is a data line, we expect two numerical fields
          String[] fields = line.split("\\s+");
          if (fields.length != 2) {
            throw new LocalException("syntax error at line " + l + ": " + line
                                     + "(expected two fields, found"
                                     + fields.length + ")");
          }

          // parse the fields and add the point to the list
          list.add(new Point2D.Double(Double.parseDouble(fields[0]),
                                      Double.parseDouble(fields[1])));

        }
      }
      Point2D.Double[] points =
        (Point2D.Double[]) list.toArray(new Point2D.Double[list.size()]);

      DecimalFormat format =
        new DecimalFormat("000.00000000",
                          new DecimalFormatSymbols(Locale.US));

      // fit a circle to the test points
      CircleFitter fitter = new CircleFitter();
      fitter.initialize(points);
      System.out.println("initial circle: "
                         + format.format(fitter.getCenter().x)
                         + " "     + format.format(fitter.getCenter().y)
                         + " "     + format.format(fitter.getRadius()));

      // minimize the residuals
      int iter = fitter.minimize(100, 0.1, 1.0e-12);
      System.out.println("converged after " + iter + " iterations");
      System.out.println("final circle: "
                         + format.format(fitter.getCenter().x)
                         + " "     + format.format(fitter.getCenter().y)
                         + " "     + format.format(fitter.getRadius()));

    } catch (IOException ioe) {
      System.err.println(ioe.getMessage());
      System.exit(1);
    } catch (LocalException le) {
      System.err.println(le.getMessage());
      System.exit(1);
    }
  }

  /** Build a new instance with a default current circle.
   */
  public CircleFitter() {
    center = new Point2D.Double(0.0, 0.0);
    rHat   = 1.0;
    points = null;
  }


  /** Initialize an approximate circle based on all triplets.
   * @param points circular ring sample points
   * @exception LocalException if all points are aligned
   */
  public void initialize(Point2D.Double[] points)
    throws LocalException {

    // store the points array
    this.points = points;

    // analyze all possible points triplets
    center.x = 0.0;
    center.y = 0.0;
    int n = 0;
    for (int i = 0; i < (points.length - 2); ++i) {
      Point2D.Double p1 = (Point2D.Double) points[i];
      for (int j = i + 1; j < (points.length - 1); ++j) {
        Point2D.Double p2 = (Point2D.Double) points[j];
        for (int k = j + 1; k < points.length; ++k) {
          Point2D.Double p3 = (Point2D.Double) points[k];

          // compute the triangle circumcenter
          Point2D.Double cc = circumcenter(p1, p2, p3);
          if (cc != null) {
            // the points are not aligned, we have a circumcenter
            ++n;
            center.x += cc.x;
            center.y += cc.y;
          }
        }
      }
    }

    if (n == 0) {
      throw new LocalException("all points are aligned");
    }

    // initialize using the circumcenters average
    center.x /= n;
    center.y /= n;
    updateRadius();

  }

  /** Update the circle radius.
   */
  private void updateRadius() {
    rHat = 0;
    for (int i = 0; i < points.length; ++i) {
      double dx = points[i].x - center.x;
      double dy = points[i].y - center.y;
      rHat += Math.sqrt(dx * dx + dy * dy);
    }
    rHat /= points.length;
  }

  /** Compute the circumcenter of three points.
   * @param pI first point
   * @param pJ second point
   * @param pK third point
   * @return circumcenter of pI, pJ and pK or null if the points are aligned
   */
  private Point2D.Double circumcenter(Point2D.Double pI,
                                      Point2D.Double pJ,
                                      Point2D.Double pK) {

    // some temporary variables
    Point2D.Double  dIJ = new Point2D.Double(pJ.x - pI.x, pJ.y - pI.y);
    Point2D.Double  dJK = new Point2D.Double(pK.x - pJ.x, pK.y - pJ.y);
    Point2D.Double  dKI = new Point2D.Double(pI.x - pK.x, pI.y - pK.y);
    double sqI = pI.x * pI.x + pI.y * pI.y;
    double sqJ = pJ.x * pJ.x + pJ.y * pJ.y;
    double sqK = pK.x * pK.x + pK.y * pK.y;

    // determinant of the linear system: 0 for aligned points
    double det = dJK.x * dIJ.y - dIJ.x * dJK.y;
    if (Math.abs(det) < 1.0e-10) {
      // points are almost aligned, we cannot compute the circumcenter
      return null;
    }

    // beware, there is a minus sign on Y coordinate!
    return new Point2D.Double(
           (sqI * dJK.y + sqJ * dKI.y + sqK * dIJ.y) / (2 * det),
          -(sqI * dJK.x + sqJ * dKI.x + sqK * dIJ.x) / (2 * det));

  }

  /** Minimize the distance residuals between the points and the circle.
   * <p>We use a non-linear conjugate gradient method with the Polak and
   * Ribiere coefficient for the computation of the search direction. The
   * inner minimization along the search direction is performed using a
   * few Newton steps. It is worthless to spend too much time on this inner
   * minimization, so the convergence threshold can be rather large.</p>
   * @param maxIter maximal iterations number on the inner loop (cumulated
   * across outer loop iterations)
   * @param innerThreshold inner loop threshold, as a relative difference on
   * the cost function value between the two last iterations
   * @param outerThreshold outer loop threshold, as a relative difference on
   * the cost function value between the two last iterations
   * @return number of inner loop iterations performed (cumulated
   * across outer loop iterations)
   * @exception LocalException if we come accross a singularity or if
   * we exceed the maximal number of iterations
   */
  public int minimize(int iterMax,
                      double innerThreshold, double outerThreshold)
    throws LocalException {

    computeCost();
    if ((J < 1.0e-10) || (Math.sqrt(dJdx * dJdx + dJdy * dJdy) < 1.0e-10)) {
      // we consider we are already at a local minimum
      return 0;
    }

    double previousJ = J;
    double previousU = 0.0, previousV = 0.0;
    double previousDJdx = 0.0, previousDJdy = 0.0;
    for (int iterations = 0; iterations < iterMax;) {

      // search direction
      double u = -dJdx;
      double v = -dJdy;
      if (iterations != 0) {
        // Polak-Ribiere coefficient
        double beta =
          (dJdx * (dJdx - previousDJdx) + dJdy * (dJdy - previousDJdy))
        / (previousDJdx * previousDJdx + previousDJdy * previousDJdy);
        u += beta * previousU;
        v += beta * previousV;
      }
      previousDJdx = dJdx;
      previousDJdy = dJdy;
      previousU    = u;
      previousV    = v;

      // rough minimization along the search direction
      double innerJ;
      do {
        innerJ = J;
        double lambda = newtonStep(u, v);
        center.x += lambda * u;
        center.y += lambda * v;
        updateRadius();
        computeCost();
      } while ((++iterations < iterMax)
               && ((Math.abs(J - innerJ) / J) > innerThreshold));

      // global convergence test
      if ((Math.abs(J - previousJ) / J) < outerThreshold) {
        return iterations;
      }
      previousJ = J;

    }

    throw new LocalException("unable to converge after "
                             + iterMax + " iterations");

  }

  /** Compute the cost function and its gradient.
   * <p>The results are stored as instance attributes.</p>
   */
  private void computeCost() throws LocalException {
    J    = 0;
    dJdx = 0;
    dJdy = 0;
    for (int i = 0; i < points.length; ++i) {
      double dx = points[i].x - center.x;
      double dy = points[i].y - center.y;
      double di = Math.sqrt(dx * dx + dy * dy);
      if (di < 1.0e-10) {
        throw new LocalException("cost singularity:"
                                 + " point at the circle center");
      }
      double dr    = di - rHat;
      double ratio = dr / di;
      J    += dr * (di + rHat);
      dJdx += dx * ratio;
      dJdy += dy * ratio;
    }
    dJdx *= 2.0;
    dJdy *= 2.0;
  }

  /** Compute the length of the Newton step in the search direction.
   * @param u abscissa of the search direction
   * @param v ordinate of the search direction
   * @return value of the step along the search direction
   */
  private double newtonStep(double u, double v) {

    // compute the first and second derivatives of the cost
    // along the specified search direction
    double sum1 = 0, sum2 = 0, sumFac = 0, sumFac2R = 0;
    for (int i = 0; i < points.length; ++i) {
      double dx     = center.x - points[i].x;
      double dy     = center.y - points[i].y;
      double di     = Math.sqrt(dx * dx + dy * dy);
      double coeff1 = (dx * u + dy * v) /  di;
      double coeff2 = di - rHat;
      sum1         += coeff1 * coeff2;
      sum2         += coeff2 / di;
      sumFac       += coeff1;
      sumFac2R     += coeff1 * coeff1 / di;
    }

    // step length attempting to nullify the first derivative
    return -sum1 / ((u * u + v * v) * sum2
                    - sumFac * sumFac / points.length
                    + rHat * sumFac2R);

  }

  /** Get the circle center.
   * @return circle center
   */
  public Point2D.Double getCenter() {
    return center;
  }

  /** Get the circle radius.
   * @return circle radius
   */
  public double getRadius() {
    return rHat;
  }

  /** Local exception class for algorithm errors. */
  public static class LocalException extends Exception {
    /** Build a new instance with the supplied message.
     * @param message error message
     */
    public LocalException(String message) {
      super(message);
    }
  }

  /** Current circle center. */
  private Point2D.Double center;

  /** Current circle radius. */
  private double rHat;

  /** Circular ring sample points. */
  private Point2D.Double[] points;

  /** Current cost function value. */
  private double J;

  /** Current cost function gradient. */
  private double dJdx;
  private double dJdy;

}