Next Article in Journal
Water Resources Monitoring in a Remote Region: Earth Observation-Based Study of Endorheic Lakes
Previous Article in Journal
Best Scanline Determination of Pushbroom Images for a Direct Object to Image Space Transformation Using Multilayer Perceptron
Previous Article in Special Issue
Research on a Matching Method for Vehicle-Borne Laser Point Cloud and Panoramic Images Based on Occlusion Removal
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Fast Robust Point Cloud Registration Based on Compatibility Graph and Accelerated Guided Sampling

1
ZNDY of Ministerial Key Laboratory, Nanjing University of Science and Technology, Nanjing 210094, China
2
School of Mechanical Engineering, Nanjing University of Science and Technology, Nanjing 210094, China
*
Author to whom correspondence should be addressed.
These authors contributed equally to this work.
Remote Sens. 2024, 16(15), 2789; https://doi.org/10.3390/rs16152789
Submission received: 18 June 2024 / Revised: 26 July 2024 / Accepted: 27 July 2024 / Published: 30 July 2024

Abstract

:
Point cloud registration is a crucial technique in photogrammetry, remote sensing, etc. A generalized 3D point cloud registration framework has been developed to estimate the optimal rigid transformation between two point clouds using 3D key point correspondences. However, challenges arise due to the uncertainty in 3D key point detection techniques and the similarity of local surface features. These factors often lead to feature descriptors establishing correspondences containing significant outliers. Current point cloud registration algorithms are typically hindered by these outliers, affecting both their efficiency and accuracy. In this paper, we propose a fast and robust point cloud registration method based on a compatibility graph and accelerated guided sampling. By constructing a compatible graph with correspondences, a minimum subset sampling method combining compatible edge sampling and compatible vertex sampling is proposed to reduce the influence of outliers on the estimation of the registration parameters. Additionally, an accelerated guided sampling strategy based on preference scores is presented, which effectively utilizes model parameters generated during the iterative process to guide the sampling toward inliers, thereby enhancing computational efficiency and the probability of estimating optimal parameters. Experiments are carried out on both synthetic and real-world data. The experimental results demonstrate that our proposed algorithm achieves a significant balance between registration accuracy and efficiency compared to state-of-the-art registration algorithms such as RANSIC and GROR. Even with up to 2000 initial correspondences and an outlier ratio of 99%, our algorithm achieves a minimum rotation error of 0.737° and a minimum translation error of 0.0201 m, completing the registration process within 1 s.

1. Introduction

Point cloud registration is a fundamental task in remote sensing [1,2], robot perception [3,4], photogrammetry [5], and other fields, and has been applied to a variety of technologies such as 3D reconstruction [6], structural health monitoring [7,8], target recognition and localization [9], simultaneous localization, and mapping [10]. Due to the fixed limitations of the laser scanner in terms of field of view and viewpoints, a single data acquisition with fixed viewpoints can only capture part of the point cloud of a scene. In order to obtain a complete 3D representation of the scene, it is necessary to fuse and splice the point clouds with different viewpoints. The goal of point cloud registration lies in estimating the optimal rigid transformation between the two point clouds in order to accurately align the point clouds under different viewpoints.
The feature-based global registration method is the mainstream method for point cloud registration [11]. It generally consists of two stages: the feature extraction stage and the robust transform estimation stage. The feature extraction stage extracts key points and generates feature descriptors, and establishes the correspondence between two point clouds based on the similarity of the feature descriptors between the points. The robust transform estimation stage estimates the transformation parameters between two point clouds based on the correspondence. Many well-differentiated point cloud description methods have been proposed, such as FPFH [12], RoPS [13], SDASS [14], etc. However, noise is still unavoidable, mainly due to (1) Most of the point clouds partially overlapping, so the established correspondences may be inliers only if they are located in overlapping regions, while correspondences in non-overlapping regions introduce a large number of outliers. (2) The presence of many similar local surfaces in the point cloud, resulting in very similar corresponding feature descriptors, and forming false correspondences. Since the correspondences established in the feature extraction stage usually have a large number of outliers, the reliability of the robust transform estimation is seriously affected. Therefore, one of the difficulties in feature-based point cloud registration is how to select inliers from the correspondence containing a large number of outliers and then accurately estimate the transformation parameters.
In recent years, a large number of robust transform estimation methods have been proposed. Random sampling consistency (RANSAC) [15] is the most commonly used method in robust transform estimation. RANSAC solves the transform parameters by iteratively sampling the minimum subset, and then selects the hypothesis of the maximum number of inliers as the estimation parameter. RANSAC requires a large number of iterations and does not guarantee obtaining the optimal solution, and, moreover, it cannot deal with the situation where the outlier ratio is very high. In order to cope with the problem of a very high outlier ratio in the correspondence, many methods choose to use the geometric properties corresponding to the inliers to identify the inliers. GORE [16] utilizes geometric consistency to exclude outliers. VODRAC [17] and RANSIC [18] establish the minimum subset by judging the compatibility between the sampled points, and use the compatible subset to generate the hypothesis transformation matrix. However, pairwise consistency is not sufficient since outliers are equally likely to occasionally satisfy length consistency. SC2-PCR [19] is further used to distinguish between inliers and outliers by computing second-order spatial compatibility. These methods have been shown to be effective in improving the parameter estimation problem in the case of a high outlier ratio, but there are still some limitations, such as the extremely low computational efficiency of RANSIC when the outlier ratio is too high, which limits the practical application of the algorithm.
Despite the great progress made in current research, it is still a challenging task to determine the inliers from correspondences containing a large number of outliers. Currently, feature-based point cloud registration algorithms suffer from the following problems: (1) Due to the diversity of scenes, the outlier ratio varies in different scenes, which limits the robustness and adaptability of the algorithms. (2) When the number of correspondences is high or the outlier ratio is too high, the parameter estimation process becomes very time-consuming and inefficient. (3) How to select the inliers from a large number of outliers and estimate the transformation parameters accurately is very difficult. To address the problem of fast robust point cloud registration containing a large number of outliers, we propose a fast robust point cloud registration algorithm based on a compatibility graph and accelerated guided sampling, which can realize the accurate registration of the corresponding point cloud that is seriously contaminated by the outliers, and, at the same time, has a high computational efficiency. The contribution of this paper is mainly:
  • Constructing a compatibility graph based on the compatibility between inliers and proposing a minimum subset sampling method combining graph edge sampling and graph vertex sampling to reduce the influence of outliers on the registration results.
  • Introducing a preference-based accelerated guided sampling strategy that utilizes the hypothetical model generated during the iterative process to guide the subsequent samples to be biased toward the inliers, achieving efficient and robust point cloud registration.
  • Compared to many existing state-of-the-art methods, the proposed algorithm is able to cope with a very high outlier ratio (outlier ratio > 99%) and strikes a remarkable balance between registration accuracy and efficiency.

2. Related Works

A key step in feature-based point cloud registration algorithms is to establish the correspondences between the source and target point clouds based on local feature descriptors. Feature descriptors have been widely studied in the past decades, and traditional descriptors such as PFH [20], FPFH [12], SHOT [21], and RoPS [13] describe the local geometric structure of the point cloud from different measurements. In order to further improve the descriptive performance of descriptors, TOLDI [22], SDASS [14], and KDD [23], introducing additional information such as local reference frame or point density features can more effectively describe the local features of the point cloud and generate more reliable correspondences. With the rapid development of deep learning technology, learning-based descriptors have received more attention due to their excellent differentiation and robustness. Learning-based local feature extraction modules usually use frameworks such as point-pair features [24,25], local reference frame [26], and rotationally invariant networks [27]. These learning-based feature description methods have good generalization but are usually computationally inefficient. Recently, Transformer [28] has also been successfully applied to 3D feature matching with promising results. Predator [29] introduces an overlap-aware module based on self-crossing and self-attention. CoFiNet [30] utilizes an attentional mechanism to aggregate the contextual information between two piece point clouds. GeoTrans [31] employs a geometric Transformer module to encode rotationally invariant geometric features of point clouds, which generates model assumptions using local correspondences and performs model validation using global fitness, thus accomplishing local-to-global alignment. These algorithms are effective in detecting overlapping regions and are shown to have the potential to solve the low overlap rate registration problem. Although current feature-matching methods can establish robust correspondences, a large number of outliers in the constructed correspondence set still inevitably exist. Therefore, it is necessary to rely on model-fitting methods for robust rigid transformation estimation.
The main robust estimation methods that have been used to solve the point cloud registration problem include M-estimation [32], truncated least squares [33], Lp-paradigm [34], and RANSAC family [15]. Since a large number of outliers will inevitably exist in the initial correspondence, how to estimate the accurate model parameters from the data containing a large number of outliers is the difficulty of robust transformation. In order to solve this problem, many researchers have proposed registration algorithms based on outlier filtering, and the core of these methods lies in removing the wrong matches in the correspondences, so as to avoid dealing with outliers in the registration process. Fast global registration (FGR) [35] is one of the typical algorithms that removes outlier points by geometric tests, then uses Geman McClure as the objective function and proposes a global method that combines a line process with robust estimation to optimize the model parameter estimation process. Similarly, Li et al. [36] constructed a topological graph based on correspondences, then proposed a side-voting strategy to remove outliers, and proposed a Cauchy-weighted Lq-paradigm as the cost function to achieve robust registration with a 90% outlier rate. A guaranteed outlier removal strategy was introduced in GORE [16], which removes outliers from correspondences by computing a simple geometric consistency test. A cleaner set of correspondences is obtained, which guarantees a globally optimal solution, but its high computational complexity leads to very low efficiency. CLIPPER [37] incorporated the concept of geometric consistency into the graph theoretic framework by finding dense subgraphs to determine the inliers. In order to improve the registration efficiency, Yang et al. [38] introduced a truncated least squares cost that is insensitive to the outliers to deal with the transformation parameter estimation problem, and rewrote the problem as a quadratically constrained quadratic programming problem. They proposed a convex semidefinite programming relaxation for the optimal solution, which can achieve the computation of the verifiable optimal solution under the condition of 95% outliers while guaranteeing efficiency. Zhang et al. [39] proposed a point cloud registration approach based on a Maximal cluster (MAC). MAC first constructs the initial correspondence compatibility graph, then searches for the largest clusters in the graph, and finally selects the largest clusters with large weights to calculate the transformation assumptions in combination with the SVD algorithm. While this approach accurately obtains the optimal transformation parameters, it suffers from low computational efficiency. Li et al. [40] use the correspondence matrix and the generalized correspondence matrix to seek the corresponding tight upper bounds and lower bounds, and then combine them with an adaptive Cauchy’s estimator for optimal parameter estimation. Yao et al. [41] proposed a global-to-local registration method and introduced a hypergraph consistency module to learn the high-order consistency of guided sampling to obtain more reliable clusters of inliers. Second-order spatial compatibility was proposed in SC2-PCR++ [19] to distinguish the inliers from the outliers at an early stage. GROR [42] introduced the concepts of graph node reliability and graph edge reliability by constructing a correspondence graph to quickly and accurately remove the inliers from the outliers. Li et al. [43] proposed a maximum group correspondence selection strategy based on reliable edges, which combines the adaptive Maxwell–Boltzmann (AMB) algorithm and confidence intervals to estimate the rotation and translation parameters.
The RANSAC algorithm is another pipeline widely used in correspondence-based point cloud registration, but the randomness of the algorithm itself leads to its low accuracy and the need for a large number of samples in order to find a relatively correct solution, which is likely to fail on the data with serious contamination of outliers. Many improved algorithms have been proposed to address the problems of RANSAC [44,45,46]. Maximum Likelihood Estimated Sample Consistency (MLESAC) [47] improves the robustness of RANSAC by replacing the cost function from the size of the consistent samples to maximize the likelihood. Locally Optimized RANSAC (LO-RANSAC) [45] performs local optimization by deriving solutions from random samples, which improves speed by two to three times compared to standard RANSAC. Wu et al. [48] introduced a particle swarm optimization algorithm in RANSAC to directly sample the model parameters and achieved good results in image alignment. GESAC [49] introduced a graph to enhance the sample consistency and achieved effective registration even if there are outliers in the smallest subset of the sampled points. ICOS [50] accelerated the search for inliers by constructing a compatibility structure. One-Point RANSAC [32] introduced a scale-annealing bi-weighted estimator to stepwise optimize the estimation of the transform parameters. Invariant and compatible random selection of minimum subsets are introduced in RANSIC [18]. Hu et al. [17] proposed a fast robust point cloud registration algorithm based on election-compatible weighted two-point random sampling (VODRAC), which combines scale-invariant constraints with a two-point random sampling framework, and can achieve fast candidate inliers search. Cheng et al. [51] proposed a point cloud registration algorithm based on local sampling and global hypothesis generation. Gentner et al. [52] proposed a graph-based maximum consistency alignment algorithm (GMCR), in which a novel consistency function was introduced specifically to translate the consistency maximizing objective into the graph domain. The algorithm is robust to various types of outliers. C-RANSAC [53] introduces a scale histogram-based outlier filtering method and involves a master–slave handshake mechanism for optimal parameter estimation, which achieves high-accuracy registration and fast convergence.

3. Methods

In this Section, we propose a novel fast robust point cloud registration based on a compatibility graph and accelerated guided sampling. We first introduce the problem formulation of registration and describe the framework of the proposed method. Then, we introduce in detail the key processes, including the correspondence compatibility graph construction, the minimum compatible subset sampling, the preference-based guided sampling strategy, and the complete registration algorithm.

3.1. Problem Formulation

The procedure of the feature-based point cloud registration algorithm is to establish the correspondences between the source and target point clouds based on the local feature descriptors, and then estimate the registration parameters based on the correspondences. We first give the method of the correspondence establishment. Assume that the two point clouds to be aligned are called source point cloud P s and target point cloud P t . (1) Due to the excessive number of points in the initial point cloud, which contains a large amount of redundant information, the key point estimation technique is first used to estimate the key points P s f = x i | 1 i N and P t f = y j | 1 j N of the source and target point clouds, respectively. (2) Generate feature description vectors for key points using feature descriptors, e.g., classical FPFH, learning-based GeoTrans. (3) For each key point x i in P s f , the nearest neighbor y i corresponding to x i in P t f is obtained based on the feature description vectors using a KD-Tree, so that the initial correspondence set C = x i ,   y i | 1 i N of P s and P t can be established.
Since P s and P t are usually partially overlapping, and the feature descriptors cannot completely and accurately distinguish each point in P s and P t , a large number of incorrect correspondences inevitably exist in C. The purpose of the feature-based point cloud registration method is to estimate the transformation parameters of the source and target point clouds based on the correspondence set. The objective function is denoted as
m i n i m i z e R , t i = 1 N | | y i ( R x i + t ) | | 2
where RSO(3) is an orthogonal rotation matrix, t is a 3 × 1 translation vector, ( x i , y i ) is a correspondence in the correspondence set C, · denotes L2-norm.
Due to the large number of wrong correspondences in the initial correspondences, the above objective function can be further expressed as a maximizing consensus problem, denoted as
m a x i m i z e R , t , I C | I | S u b j e c t       t o   | | y i ( R x i + t ) | | < ε , ( x i , y i ) I
where I is called the consensus set, |I| denotes the size of the consensus set, ε is an inliers threshold, and (R, t) corresponding to the consensus set is considered to be the optimal transformation parameter. In order to search for the maximum consensus set in the initial correspondences, the commonly adopted approach is to sample a series of minimum subsets (a subset consisting of three points) from the initial correspondences for estimating (R, t), and then to compute the correspondences in the initial correspondences that are consistent with the minimum subset, i.e., correspondences that satisfy | | y i R x i + t | | < ε . Finally, the set with the most consensus correspondences is selected as the maximum consensus set. To address the above question, we propose a sampling consistency algorithm that combines a compatibility graph and accelerated guided sampling. The overall framework of the algorithm is shown in Figure 1, by constructing the compatibility graph structure of the initial correspondences, combining graph edge sampling and graph vertex sampling to obtain the minimum compatible subset, and introducing a preference-based accelerated guided sampling strategy to search for the optimal minimum subset so as to determine the maximum consensus set and estimate the transformation parameters.

3.2. Correspondence Compatibility Graph Construction

In our approach, the selection of the inliers of the correspondences will be performed on a graph structure, which is a better representation of the compatibility degree between correspondences than the Euclidean distance space. Therefore, it is first necessary to construct an undirected graph of the initial correspondences, where each correspondence is represented as a graph vertex, and geometrically compatible nodes are connected by graph edges.
For the initial correspondence set C, suppose that two elements in C are c i = ( p s i , p t i ) and c j = ( p s j , p t j ), where p s i , p s j denote two points in the source point cloud and p t i , p t j denote two points in the target point cloud corresponding to p s i , p s j . The compatibility between c i and c j can be quantitatively measured as
d c m p ( c i , c j ) =   p s i p s j p t i p t j   .
When c i and c j are ideal inliers, d c m p ( c i , c j ) = 0. Noise inevitably exists in the point cloud, and d c m p ( c i , c j ) cannot be strictly 0. Therefore, when d c m p ( c i , c j ) < ε, it indicates that c i and c j are compatible and considered to be inliers.
Construct a compatibility graph based on the compatibility between any vertices, given an initial set of correspondences C = { c i | 1 i N } , the graph formed by them denoted as G = (V, E), with V being the vertices of the graph and V = { c i | 1 i N } , E being the edges of the graph and E = { e i j | 1 i N , 1 i N } , where e i j = ( c i , c j ). In the process of constructing the graph, for two correspondences c i and c j , they are considered compatible so that e i j is in E only when d c m p ( c i , c j ) < ε, and in this way the compatibility graph of C is constructed. At the same time, we build an N × N compatibility matrix M C , and when d c m p ( c i , c j ) < ε, the corresponding positional element of M C , M C (i, j) = 1, which indicates that the correspondences c i and c j are compatible, and M C (i, j) = 0, otherwise denoted as:
M C ( i , j ) = 1 ,   i f   d c m p ( c i , c j ) < ε 0 ,   o t h e r w i s e

3.3. Minimum Compatible Subset Sampling

In the traditional RANSAC algorithm, point cloud registration requires randomly selecting three correspondences to form a minimum subset, and then combining them with Horn’s triad-based method [54] to estimate the transformation parameters between two point clouds. Due to the presence of a large number of outliers, the probability of RANSAC sampling to a minimum subset of all inliers is extremely low. According to [17], when the outlier ratio in the correspondences is certain, the number of iterations required for RANSAC to sample a subset of all inliers grows exponentially with the size of the minimum subset, and a large number of iterations are often required to obtain a more optimal solution. In order to reduce the influence of the outliers, this paper introduces a compatible minimum subset sampling method based on the constructed compatibility graph, and the method consists of two layers, the edge sampling layer, and the vertex sampling layer.
In the edge sampling layer, we first randomly select an edge e i j = ( c i , c j ) in the compatibility graph, and search the vertices connected to this edge to form a triangle as the candidate correspondence set Φ = { c k |0 ≤ kK}. Then, enter the vertex sampling layer and randomly select a point c k in Φ, with e i j forming a minimal subset s k = { c i , c j , c k }. Next, we use Horn’s method to compute the rotation and translation parameters, and compute the consensus set L k corresponding to the smallest subset s k of the candidate correspondence set Φ from the estimated transformation parameters. Repeat sampling in Φ until reaching the set maximum iteration number of vertex sampling M I v to obtain a series of consensus sets L V = { L k |0 ≤ k M I v }, and always retain the largest consensus set in L V as the best consensus set for the vertex sampling layer, i.e., L b e s t = a r g m a x L k L v L k . To avoid too much redundant computation, each time we obtain a new L b e s t , we update M I v according to L b e s t . After the vertex sampling layer is completed, return to the edge sampling layer and use L b e s t to compute the transformation parameters, and calculate the consensus set G n corresponding to the currently sampled edge in the initial correspondence C. Repeat the edge sampling until reaching the set maximum iteration number M I e of edge sampling, and the iterative process generates a series of consensus sets G E = { G n |0 ≤ n M I e }. Always retain the maximum consensus set G b e s t = a r g m a x G n G E G n during the iterative process. Similarly, each time we obtain a new G b e s t , we update M I e according to G b e s t . Finally, estimate the registration parameters using SVD [55] based on G b e s t . We dynamically adjust the maximum iteration number M I e of edge sampling and the maximum iteration number M I v of vertex sampling according to the consensus set size. Similarly to RANSAC [15], the maximum iteration number is updated by the following rule.
M I v = log ( 1 P 1 ) log 1 | L b e s t | | Φ |
M I e = log ( 1 P 2 ) log 1 | G b e s t | N 2
where · denotes the set size. P 1 and P 2 denote the probability of sampling at least one all-inlier subset for vertex sampling and edge sampling, respectively, and we set P 1 = P 2 = 0.99.

3.4. Preference-Based Guided Sampling Strategy

For an established compatibility graph, given a vertex c n G in the graph and c n denotes a correspondence, define the set of vertices in the compatibility graph that are compatible with c n as
N c n = { c n | M C ( n , n ) = 1 } .
Based on the constructed compatibility graph G, according to the introduced minimum compatible subset sampling method, compatible edges are sampled in the graph and combined with compatible vertices to estimate the model, and a locally optimal model hypothesis can be obtained for each compatible edge sampled. Assuming that M edges are initially sampled through iterations, M model hypotheses are generated accordingly, denoted as H = { h m | 1 m M } , where h m = ( R m , t m ), and the M+1th model is generated by the guided sampling strategy. Specifically, for each data c n = ( x n , y n ), we compute the residual distance r( c n , h m ) = | | y n R m x n + t m | | of c n with respect to the mth model hypothesis based on the Euclidean distance. We then introduce the preference function, which represents the degree of preference of a correspondence c n over a model hypothesis h m , as follows:
f m n = e r 2 ( c n , h m ) / δ 2 , i f   r ( c n , h m ) < τ m 0 , o t h e r w i s e
where τ m is an inlier threshold and δ is a regularization constant. Thus, the preferences of a correspondence c n for M model hypotheses in the set of model hypotheses H can be expressed as a set f n = f 1 n ,   f 2 n , , f M n . For any two correspondences c n and c n , whose preference vectors are computed as f n and f n , respectively. We use cosine similarity to compute the residual correlation between the two correspondences, denoted as
φ ( c n , c n ) = f n , f n | | f n | | × | | f n | |
where · , · and · denote the inner product and L2 norm, respectively. It is intuitive that inliers should be compatible with each other, and inliers should share many of the same modeling assumptions with each other. Thus, if two correspondences c n and c n are inliers, the corresponding similarity scores of them are high. Otherwise, if c n and c n are outliers, they do not have similar preferences for different modeling assumptions, so the corresponding similarity scores will be low.
Based on the mutual compatibility between inliers, high similarity scores of inliers should be accompanied by the existence of edge connections, so the similarity between c n and c n is further defined as
w ( c n , c n ) = φ ( c n , c n ) , c n N c n 0 , c n N c n
where N c n donates the set of vertices in the compatibility graph that are compatible with c n , and satisfies Equation (7). Thus, the similarity scores of the spatially incompatible correspondences are set to 0, in which case the similarity matrix M s between the correspondences can be obtained and M s n , n = w c n , c n . Assuming that c n is fixed, the similarity score between c n and the jth corresponding c j in C is D n j = M s n , j . Finally, the similarity between c n and the rest of the data in C constitutes an association vector D n
D n = [ D n 1 , D n 2 , , D n j , , D n N ] .
As in [56], define the gap γ j as the difference between the maximum value of D n and D n j
γ j = max ( D n ) D n j
γ j is not less than 0, the smaller γ j is, the more similar c n is to c j . Define the probability of γ j as
η ( γ j ) = γ j / k = 1 N γ k
According to [57], the information provided by the jth correspondence is denoted as
e j = log ( η ( γ j ) + ξ )
where ξ is a small positive value, and the sum of the information entropies of the remaining points in C on c n is
E P n = j = 1 N η ( γ j ) e j .
The information entropy is computed for each vertex in G to form the vector E P = E P n n = 1 N . The smaller E P n indicates that c n is more likely to be an inlier, so the vertex with smaller information entropy is selected according to EP as the set of vertices participating in the subsequent sampling of the compatible edges for the next model estimation. The vertex selection strategy is denoted as follows.
χ = { c n | E P n < m e a n ( E P ) } .
Using this method to select significant vertices that are more likely to be inliers, and sampling compatible edges in the set of significant vertices in the next iteration, effectively increases the probability of sampling the smallest subset of all inliers and speeds up the estimation of the optimal model.

3.5. Complete Registration Algorithm

Based on the compatibility graph and preference-guided sampling, we further propose a complete correspondence-based point cloud registration algorithm for clouds with a high outlier ratio. In order to control the selection process of significant vertices, we define a batch size b as well as a maximum inlier update time max_up. b controls the frequency of vertex information entropy computation; i.e., we perform the vertex information entropy computation only for every b model hypothesis generated. And max_up is used as the end condition of the algorithm; i.e., after significant vertices have been selected max_up times, it is considered that the inliers have been involved in enough iterations to have obtained the exact transformation parameters; i.e., it is considered that the optimal solution has been obtained and the iteration is ended. The flow of the algorithm is shown in Algorithm 1.
Algorithm 1. Proposed Method
Remotesensing 16 02789 i001

4. Experimental Results

To validate the effectiveness of the proposed algorithm, we conducted a series of experiments on several datasets, including the synthetic dataset Stanford 3D Scanning Repository dataset, the indoor dataset 3DMatch, the low-overlap indoor dataset 3DLoMatch, and the outdoor dataset KITTI. The addresses of all datasets can be seen in the Data Availability Statement.
The Stanford 3D Scanning Repository dataset contains several mesh models, which were obtained by scanning with a range scanner, followed by registration and surface reconstruction techniques. In order to verify the basic performance of our algorithm, we constructed test data pairs by randomly generating rotation matrices and translation vectors as ground truth transformations. 3Dmatch [58] is a point cloud dataset of eight indoor scenes obtained from RGBD sequences, containing a total of 1623 test pairs, each with a real camera pose and an overlap of more than 30%. 3DLoMatch [29] is a dataset of the same eight scenes with an overlap of between 10% and 30%, containing a total of 1781 pairs. KITTI [59] is a large-scale outdoor LIDAR dataset, which provides 11 sequences with pose annotations. Its ground truth transformations are obtained by GPS with refinement by the standard iterative closest point (ICP) algorithm [60]. This dataset contains several thousand frames of data in each sequence, and data in the same sequence have a high overlap rate.

4.1. Synthetic Data Experiment

We use the armadillo [61] point cloud model from the Stanford 3D Scanning Repository dataset for basic performance validation of the algorithm. First, 1000 points are sampled in the initial point cloud model as key points P s , then its scale is changed so that the point cloud is inside a 1m×1m×1m enclosing box. And then rigid transformation RSO(3) and tR3 are randomly generated and the initial point cloud model is transformed to obtain the transformed point cloud, where the transformed key points are P t . To make the experiment closer to the real situation, we add Gaussian noise with a mean value of 0 and a standard deviation σ = 0.01 to the transformed key points P t to simulate the noise present in the actual collected data, and obtain an inlier set C i n = ( P s , P t ). To obtain the outliers, we generate N o u t random points Q o u t in a spherical space with the center of gravity of P t as the spherical center and the length of the diagonal of the bounding box of P t as the radius. Then, randomly select N o u t points P o u t in P s and release P o u t from matching with the corresponding points in P t . Next, establish the correspondence between P o u t and Q o u t to form the outlier set C o u t = ( P o u t , Q o u t ), and the corresponding set C containing outliers is obtained by replacing the positions in C i n with the same index as C o u t . In order to simulate the case of different outlier ratios, by changing the value of N o u t , set the outlier ratio at {20%, 40%, 60%, 80%, 90%, 92%, 94%, 96%, 98%, 99%}. Figure 2 shows the key points obtained by subsampling the point cloud and the initial correspondences of different outlier ratios, respectively. Due to the randomness of the noise distribution, each experiment is repeated 50 times to ensure the stability of the results.
In order to quantitatively assess the performance of the registration algorithms, the widely used rotation error ( E R ) and translation error ( E t ) are used as evaluation criteria [62], which are respectively
E R = | arccos t r ( R G T T R e ) 1 2 | 180 ° π E t = | | t G T t e | |
where R G T and t G T denote the true values of the rotation and translation matrices, respectively. R e and t e denote the estimated values of the rotation and translation matrices, respectively, computed by the registration algorithm. tr(·) denotes the trace of the matrix. E R is used to measure the angular difference between R G T and R e , and E t is used to measure the Euclidean distance between t G T and t e . In addition, we evaluate the efficiency of the algorithm by comparing the running time ( T c ) required for the registration.
In order to test the influence of the algorithm parameters on the experimental results, parameter analysis experiments are carried out. The main parameters involved in the proposed algorithm are the batch size b and the maximum number of updates of the inliers set max_up. For b, we first set max_up = 3, and increase b from 10 to 50 in steps of 10. Then we fix b to 20, and increase max_up from 2 to 6 in steps of 1. Experiments were carried out on data with different outlier ratios, and each parameter condition was run 50 times to record the mean rotation error, mean translation error, and mean time cost. The results of the experiments are shown in Figure 3.
According to the results, it can be seen that when b = 10, the rotation error and translation error are large; this is because at this time it is not possible to fully sample the inliers, resulting in the results having a larger error. When b = 20, the rotation and translation errors are relatively small, while the computational efficiency is high, and the accuracy and efficiency are in good balance. The time cost will increase significantly if b continues to increase. For max_up, when the outlier ratio is less than 98%, max_up has less influence on the experimental results. When the outlier ratio is 99%, max_up = 3 corresponds to a small mean rotation error and mean translation error. At the same time, the time cost is very little, which achieves a good balance in terms of accuracy and efficiency. Therefore, in this paper, b and max_up are set to 20 and 3, respectively.
In order to verify the performance of our algorithm equivalent to advanced robust point cloud registration algorithms, we compare the proposed method with six state-of-the-art algorithms, namely, RANSAC [15], GORE [16], One-Point RANSAC [32], GROR [42], RANSIC [18], and VODRAC [17]. Among these algorithms, RANSAC is the widely used initial registration algorithm, GORE and GROR are the most recently proposed provable and have good outlier filtering performance. One-Point RANSAC, RANSIC, and VODRAC are recently proposed state-of-the-art algorithms and show excellent performance in point cloud registration tasks heavily contaminated by outliers. Specifically, we set the maximum number of iterations to 10 5 for all RANSAC-type algorithms and set the inlier threshold to 6pr for all algorithms, where pr denotes the resolution of the input point cloud [63]. pr is obtained by summing and averaging the distances between each point and its nearest neighbor. The parameters of the different algorithms are shown in Table 1 and are the same for the rest of the experiments.
The registration results of different algorithms are shown in Figure 4 and some visualization results are shown in Figure 5. From the results, it can be seen that RANSAC can be useful when the outlier ratio is lower than 80%. The algorithm fails when the outlier ratio continues to increase, and the rotation and translation errors of the parameters estimated by RANSAC are large. GORE maintains a stable performance under different outlier ratios due to its ability to reliably remove the outliers and its robustness to noise. However, it exhibits limited registration accuracy, and the computational complexity of GORE is high. The time it takes to complete registration is usually several orders of magnitude higher compared to the other algorithms. When the outlier ratio is lower than 98%, One-Point RANSAC shows competitive performance in terms of registration accuracy and registration efficiency, but when the outlier ratio is 99%, the registration accuracy of the algorithm decreases rapidly, and the algorithm usually fails to estimate the correct registration parameters. GROR maintains good registration accuracy at different outlier ratios. While the registration efficiency decreases with the increase in the outlier ratio, the algorithm takes a long time to complete the registration. Both RANSIC and VODRAC have good robustness to outliers, and maintain high registration accuracy even when the outlier ratio is very high. When the outlier ratio is as high as 99%, the rotation and translation errors of the parameter estimated by RANSIC are about 1.221° and 0.0061 m, respectively, and the rotation and translation errors of the parameter estimated by VODRAC are about 1.655° and 0.0075 m. The registration efficiency of VODRAC increases first and then decreases with the increase in the outlier ratio. When the outlier ratio is 80%, the registration efficiency is highest, and it takes about 0.085 s to complete the registration. When the outlier ratio is lower than 96%, the registration efficiency of RANSIC is very high, and is higher than that of VODRAC. When the outlier ratio is higher than 96%, the time required for RANSIC to complete the registration increases significantly, and when the outlier ratio is 99%, RANSIC takes about 20.46 s to complete the registration.
As can be seen from the results, the proposed algorithm has excellent performance in terms of rotation error, translation error, and time cost. When the outlier ratio is lower than 96%, compared with other algorithms, the proposed algorithm exhibits remarkably low levels of both rotation and translation errors, and its time cost remains consistently stable at 0.035 s. When the outlier ratio is higher than 96%, the proposed algorithm still maintains a very high registration accuracy. When the outlier ratio is 96% and 98%, the proposed algorithm efficiency is significantly higher than the RANSIC and VODRAC algorithms. When the outlier ratio is 99%, One-Point RANSAC is no longer able to accurately estimate the registration parameters despite its low time cost, while the proposed algorithm still has a high accuracy. The excellent performance of the algorithm proposed in this paper can be attributed to the following factors: (1) The compatibility graph is constructed with full consideration of the compatibility relationship between the inliers, which can avoid the influence of the outliers on the registration results and ensure the accuracy of the algorithm. (2) The minimum subset sampling is split from three-point random sampling into compatible edge sampling and candidate subset sampling, which effectively reduces the computational complexity. (3) A guided accelerated sampling strategy is introduced, by calculating the preference between the correspondence and the estimated parameter to determine the inliers faster, which effectively improves the speed of convergence of the parameter estimation.

4.2. Challenging Real-World Data Experiments

To evaluate the registration performance of the proposed algorithm on real-world data, we conduct registration experiments using the 3DMatch dataset [58], which contains a total of 8 scenes, namely, Kitchen, Home1, Home2, Hotel1, Hotel2, Hotel3, Studyroom, and Lab. In each scene, we select 20 data pairs that overlap as test data. For each data pair, we adopt the Harris3D key point detection algorithm [64] to sample about 2000 key points in the source and target point clouds, respectively. Then, we use the FPFH [12] descriptor to obtain the feature vectors of the key points, and then further establish the initial correspondences between the two point clouds based on the feature descriptors. A pair of data is selected from each scene, and the initial correspondences are shown in Figure 6, where the red lines indicate the wrong correspondences, i.e., the outliers, and the green lines indicate the correct correspondences, i.e., the inliers. It can be seen that the initial correspondence set is contaminated by a large number of outliers, which makes it extremely challenging to align accurately.
The registration experiments on the 3DMatch dataset also compare six registration algorithms, including RANSAC, GORE, GROR, One-Point RANSAC, RANSIC, and VODRAC. We compare the rotation error, translation error, and time cost of the different algorithms. In order to qualitatively demonstrate the performance of the different algorithms, we select a pair of data pairs with low overlap between the source and the target point clouds from each scene for visualization, and the results of the different algorithms are shown in Figure 7. Visually, RANSAC can only roughly align the Lab scene, and similarly, GORE performs poorly, One-Point RANSAC performs slightly better and can effectively align two scenes, and GROR has a large improvement in performance, effectively aligning six scenes, but the algorithm fails for Home2 and Hotel3. Both RANSIC and VODRAC can complete the registration of all scenes, but RANSIC takes a lot of time to align each scene, and VODRAC is more efficient but still less efficient when the initial number of correspondences is very large. Our algorithm efficiently completes the registration of all the scenes, and the registration efficiency is very high in all cases, which proves the robustness and efficiency of the proposed algorithm.
Since FPFH is a manually designed feature descriptor, the correspondences established by it usually contain a large number of outliers with an outlier ratio of up to 99%. We record the rotation error, translation error, and time consumption of different algorithms. The experimental results are shown in Figure 8. The average outlier ratios and registration results of the experimental data for different scenarios are shown in Table 2.
Registration Accuracy Analysis: As shown in Table 2, the initial correspondences contain a large number of outliers, and the average outlier ratio of each scene is close to 99%. RANSAC can only achieve approximate registration for a few scenes, and the rotation and translation errors of most of the scenes are very large. This limitation is due to the fact that RANSAC needs to sample randomly in a large number of initial correspondences, which results in its inability to achieve effective registration within the set number of iterations. Its rotation and translation errors reach a maximum of 86.584° and 2.116 m. According to Figure 8a,b, under this condition of the number of correspondence sets and the outlier ratio, GORE and One-point RANSAC are also ineffective for most of the data pairs. They can only achieve accurate registration for a small portion of pairs, and the robustness of the algorithms needs to be further improved. In contrast, the performance of GROR is greatly improved. For most of the correspondences that are heavily contaminated by outliers, GROR can achieve accurate registration. As can be seen, many of the GROR registration results have a rotation error of less than 1°, and a translation error of less than 0.05 m. However, GROR still faces failures for individual data pairs. We speculate that this is due to the fact that an excessive number of outlier points affect the reliability of the algorithms in terms of graph node reliability and graph edge reliability, which leads to inaccurate final registration results. Under the condition that the correspondence set is heavily contaminated, RANSIC and VODRAC show excellent performance. Both of them can achieve accurate registration for each scene, in which the mean rotation error of RANSIC reaches a minimum of 0.984°, and the mean translation error reaches a minimum of 0.041 m. The mean rotation error of VODRAC reaches a minimum of 0.842° and the mean translation error reaches a minimum of 0.0302 m, which are significantly better than those of RANSAC, GORE, and One-Point RANSAC. According to the experimental results, the registration algorithm proposed in this paper reaches the advanced level in terms of registration accuracy, and can complete the accurate registration of all data pairs. The algorithm has good robustness to outliers, the mean rotation error of the registration results reaches 0.737° at the lowest level, and the mean translation error reaches 0.0201 m at the lowest level, which has a very high accuracy.
Registration efficiency analysis: Figure 8c shows the registration time distribution of different algorithms on eight scenes, and Table 2 records the average registration time of different algorithms for each scene. According to the results, it can be seen that the registration efficiency of RANSAC is low, and its running time is mainly related to the preset number of iterations, which requires a large number of iterative calculations to obtain relatively better results. The running time of GORE is very short because there are too few inliers in the correspondence. The algorithm cannot efficiently compute the upper and lower bounds, and it skips the computation of the parameter updating process. One-Point RANSAC has high running efficiency, which is due to the fact that the algorithm decomposes the registration problem, and the parameter space is drastically reduced, allowing it to quickly find what it considers to be the optimal solution. GROR has a high registration efficiency, generally taking 2~4 s to complete the registration. VODRAC has a slightly higher registration efficiency than that of GROR, which is due to the fact that it has the step of random sampling consistency decomposition. In the case of high outlier ratios, despite achieving accurate registration, the registration efficiency of RANSIC is very low, usually requiring tens or hundreds of seconds to complete the registration. In contrast, our algorithm has very high registration efficiency, and even if the initial number of correspondences reaches 2000 and is heavily contaminated by outliers, it can still compute very accurate registration results in less than 1 s in most cases.

4.3. Low-Overlap Point Cloud Registration Experiments

In order to verify the ability of the proposed algorithm to handle point cloud pairs with low overlap rate, we carried out experiments on 3DLoMatch, which contains 1781 test point cloud pairs and has a low overlap rate between point cloud pairs, with the overlap rate ranging from 10% to 30%. It is difficult to establish correspondences between these point cloud pairs by handcrafted descriptors. Recently, Transformer-based correspondence estimators have shown excellent performance on point clouds with low overlap rates to establish reliable correspondences between point cloud pairs. We use GeoTrans [31] to establish the correspondences of 3DLoMatch data and incorporate the proposed parameter estimation method to improve the registration performance. We evaluate the performance of the algorithm by using E R , E t and registration recall (RR) [65]. RR is the proportion of the results with E R , E t under the error threshold to the total number of test samples, i.e., the rate of successful registration, and we set the threshold to (15°, 0.3 m). As correspondences established using GeoTrans usually contain enough inliers, most data pairs can be successfully aligned. Following [65], since part of the failed registration can generate large rotation and translation errors, we only computed the mean rotation error ( E ¯ R ) and translation error ( E ¯ t ) of successfully registered point cloud pairs of each method to avoid unreliable metrics. A local-to-global (LGR) parameter estimation method is proposed in GeoTrans, and the experiments are compared with this method. The basic RANSAC algorithm and advanced algorithms including GROR and RANSAIC are also compared.
The experimental results obtained are shown in Table 3, and some qualitative results are shown in Figure 9. According to the experimental results, it can be seen that the proposed algorithm can effectively improve the registration recall by 3.41% compared to LGR, due to the more effective handling of the case of fewer inliers within the correspondences. As GROR and RANSIC are able to detect inliers in the correspondences, both of them provide some performance gains, while RANSAC has a poorer performance. The experiments illustrate that the proposed algorithm can effectively align point cloud pairs with very low overlap and achieve significant performance in conjunction with the learning-based descriptor.

4.4. Outdoor Scene Registration Experiments

To further validate the ability of the proposed algorithm to handle more complex scenarios, we conducted experiments on the outdoor LIDAR dataset KITTI, where the data scale of the outdoor scene is much larger than that of the indoor scene. As in [66], we selected scenes 8 to 10 as the test dataset and obtained a total of 555 test data pairs. Again, we used GeoTrans to establish the correspondences between the point cloud pairs and then combined the parameter estimation methods to estimate the registration parameters between the point cloud pairs. E ¯ R , E ¯ t , and RR are used to evaluate the experimental results, and the error threshold of RR is set to (5°, 0.6 m). LGR, RANSAC, GROR, and RANSAIC are used as comparison algorithms.
The experimental results are shown in Table 4, and some visualized results are shown in Figure 10. From the experimental results, it can be seen that LGR, RANSAIC, and the proposed algorithm obtain the highest registration recall with high parameter estimation accuracy, and the proposed algorithm reaches the optimum in terms of rotation error. RANSAC achieves high registration recall, although the estimated parameters are usually sub-optimal but mostly within acceptable range. GROR performs slightly worse on the KITTI dataset compared to the other algorithms. It is experimentally verified that the proposed algorithm has excellent performance in estimating registration parameters and is common across different scenarios.

5. Discussion

In this paper, we propose a method for solving the problem of estimating transformation parameters in feature-based point cloud registration algorithms. For feature-based point cloud registration, high outlier ratios in correspondences established by feature descriptors are a common problem. The outlier ratio in correspondences established by classical handcrafted descriptors such as FPFH is usually higher than 90%. In this case, the proposed algorithm still obtains a high registration accuracy and maintains the optimal accuracy compared to algorithms such as RANSAC, GORE, and One-Point RANSAC. Meanwhile, the proposed algorithm has high registration efficiency, which is tens times faster than RANSIC and several times faster than GROR and VODRAC under the condition of a very high outlier ratio. In conclusion, our algorithm has superior robustness, accuracy, and computational efficiency compared with other state-of-the-art methods.
In terms of algorithm generality, the proposed algorithm takes correspondences as input and outputs the final registration parameters. Point cloud registration can be accomplished by combining any feature matching and correspondence establishment methods, such as handcrafted descriptors and learning-based descriptors. Due to the advanced feature description performance of the learning-based descriptors, combining them with the proposed method can be used for point cloud registration in low-overlap and complex scenarios, and a remarkable registration performance can be obtained. Combining the proposed algorithm with GeoTrans achieves a 3.41% improvement in registration recall on low-overlap point cloud datasets compared to LGR. The algorithm can also be applied to the registration of large-scale scenarios, and the proposed algorithm combined with GeoTrans for large-scale point cloud data registration also obtains the optimal performance.
Although the proposed algorithm is able to achieve fast and robust point cloud registration, it still has some limitations. Firstly, the proposed algorithm still relies on the initial correspondences. If the number of inliers in the correspondences is too small, the proposed algorithm may not be able to find enough correct inliers for parameter estimation, leading to the failure of the algorithm. Secondly, the algorithm relies on the Euclidean distance to determine the compatibility between the correspondences. However, the Euclidean distance has an inherent ambiguity in 3D space; i.e., the Euclidean distances from the surface of the sphere to the center of the sphere are all equal. This property may lead to a lack of stability in the compatibility calculation, thus affecting the performance of the algorithm.

6. Conclusions

In this paper, we present an efficient and robust point cloud registration method that directly outputs the final alignment registration based on correspondences and excels in terms of accuracy, efficiency, and robustness. Compared to many existing techniques, the algorithm in this paper operates efficiently under very high outlier conditions and strikes an excellent balance between efficiency and accuracy. In order to minimize the influence of the outliers, this paper introduces the concept of the compatibility graph, and proposes a minimum subset sampling method for the combination of compatible edges and compatible vertices, which effectively avoids the participation of a large number of outliers in the computation. A preference-guided accelerated sampling strategy is further proposed to effectively utilize the estimated transformation parameters at the initial stage, calculate the preference score of each vertex based on the transformation parameters, and then guide the execution of the sampling in the direction of more likely to be an inlier to improve the efficiency of registration. Finally, the transformation parameters are estimated based on the maximum set of compatible vertices to complete the accurate registration. Based on a synthetic and real dataset, the proposed registration algorithm is compared and analyzed with classical and advanced algorithms. Simulation experiments demonstrate the robustness and efficiency of the algorithm, which can still accomplish registration quickly when the outlier ratio is as high as 99%. Real data show that the algorithm can successfully perform point cloud registration even if the correspondence established by the feature description contains a large number of outliers. Compared with the state-of-the-art algorithms, the proposed algorithm is able to realize a point cloud registration several times faster while maintaining a comparable or higher registration accuracy. By combining the proposed algorithm with a learning-based feature description method, the registration accuracy can be further improved and can be applied to low overlap and large-scale point cloud registration tasks.
In follow-up work, as the proposed algorithm is still closely related to the quality of the initial correspondences, and more inliers can give more accurate results, designing more reliable correspondence establishment methods will be a priority. In addition, the proposed method relies on the Euclidean distance of the correspondence to compute the compatibility, and the compatibility results obtained are not stable enough, so exploring the compatibility of the correspondence with higher orders to further improve the parameter estimation performance and registration accuracy is another future research work.

Author Contributions

Conceptualization, C.W.; Formal analysis, Z.Z.; Funding acquisition, Z.Z., B.Z. and H.L.; Methodology, C.W.; Software, C.W. and Z.Z.; Supervision, B.Z. and H.L.; Validation, Z.Z.; Visualization, B.Z.; Writing—original draft, C.W.; Writing—review and editing, C.W., B.Z. and H.L. All authors have read and agreed to the published version of the manuscript.

Funding

The research in this article was funded by the National Natural Science Foundation of China, grant number 52201399; the foundation of JWKJW Field [grant number 2022-JCJQ-JJ-0394]; the Central University Special Funding for Basic Scientific Research, grant No. 30918012201; Postgraduate Research & Practice Innovation Program of Jiangsu Province.

Data Availability Statement

All datasets used in this study are publicly available. The Stanford 3D Scanning Repository dataset is available at Stanford 3D Scanning Repository (https://graphics.stanford.edu/data/3Dscanrep/, accessed on 6 November 2023). The 3DMatch dataset is available at 3DMatch (https://3dmatch.cs.princeton.edu/, accessed on 17 December 2023). The 3DLoMatch dataset is available at Predator (https://github.com/prs-eth/OverlapPredator, accessed on 7 June 2024). The KITTI is available at KITTI Vision Benchmark Suite (https://www.cvlibs.net/datasets/kitti/eval_odometry.php, accessed on 13 June 2024).

Conflicts of Interest

The authors declare that they have no known competing financial interests or personal relationships that could have appeared to influence the work reported in this paper.

References

  1. Han, T.; Zhang, R.; Kan, J.; Dong, R.; Zhao, X.; Yao, S. A Point Cloud Registration Framework with Color Information Integration. Remote Sens. 2024, 16, 743. [Google Scholar] [CrossRef]
  2. Chen, Y.; Mei, Y.; Yu, B.; Xu, W.; Wu, Y.; Zhang, D.; Yan, X. A Robust Multi-Local to Global with Outlier Filtering for Point Cloud Registration. Remote Sens. 2023, 15, 5641. [Google Scholar] [CrossRef]
  3. Miao, Y.; Liu, Y.; Ma, H.; Jin, H. The Pose Estimation of Mobile Robot Based on Improved Point Cloud Registration. Int. J. Adv. Robot. Syst. 2016, 13, 52. [Google Scholar] [CrossRef]
  4. Hu, K.; Chen, Z.; Kang, H.; Tang, Y. 3D Vision Technologies for a Self-Developed Structural External Crack Damage Recognition Robot. Autom. Constr. 2024, 159, 105262. [Google Scholar] [CrossRef]
  5. Szabó, S.; Enyedi, P.; Horváth, M.; Kovács, Z.; Burai, P.; Csoknyai, T.; Szabó, G. Automated Registration of Potential Locations for Solar Energy Production with Light Detection And Ranging (LiDAR) and Small Format Photogrammetry. J. Clean. Prod. 2016, 112, 3820–3829. [Google Scholar] [CrossRef]
  6. Choi, S.; Zhou, Q.-Y.; Koltun, V. Robust Reconstruction of Indoor Scenes. In Proceedings of the 2015 IEEE Conference on Computer Vision and Pattern Recognition (CVPR), Boston, MA, USA, 7–12 June 2015; pp. 5556–5565. [Google Scholar]
  7. Wan, S.; Guan, S.; Tang, Y. Advancing bridge structural health monitoring: Insights into knowledge-driven and data-driven approaches. J. Data Sci. Intell. Syst. 2023, 2, 129–140. [Google Scholar] [CrossRef]
  8. Zhang, H.; Zhu, Y.; Xiong, W.; Cai, C.S. Point Cloud Registration Methods for Long-Span Bridge Spatial Deformation Monitoring Using Terrestrial Laser Scanning. Struct. Control Health Monit. 2023, 2023, 2629418. [Google Scholar] [CrossRef]
  9. Du, G.; Wang, K.; Lian, S.; Zhao, K. Vision-Based Robotic Grasping From Object Localization, Object Pose Estimation to Grasp Estimation for Parallel Grippers: A Review. Artif. Intell. Rev. 2021, 54, 1677–1734. [Google Scholar] [CrossRef]
  10. Kim, P.; Chen, J.; Cho, Y.K. SLAM-Driven Robotic Mapping and Registration of 3D Point Clouds. Autom. Constr. 2018, 89, 38–48. [Google Scholar] [CrossRef]
  11. Yang, J.; Li, H.; Campbell, D.; Jia, Y. Go-ICP: A Globally Optimal Solution to 3D ICP Point-Set Registration. IEEE Trans. Pattern Anal. Mach. Intell. 2016, 38, 2241–2254. [Google Scholar] [CrossRef]
  12. Rusu, R.B.; Blodow, N.; Beetz, M. Fast Point Feature Histograms (FPFH) for 3D Registration. In Proceedings of the 2009 IEEE International Conference on Robotics and Automation, Kobe, Japan, 12–17 May 2009. [Google Scholar]
  13. Guo, Y.; Sohel, F.; Bennamoun, M.; Lu, M.; Wan, J. Rotational Projection Statistics for 3D Local Surface Description and Object Recognition. Int. J. Comput. Vis. 2013, 105, 63–86. [Google Scholar] [CrossRef]
  14. Zhao, B.; Le, X.; Xi, J. A Novel SDASS Descriptor for Fully Encoding the Information of a 3D Local Surface. Inf. Sci. 2019, 483, 363–382. [Google Scholar] [CrossRef]
  15. Fischler, M.A.; Bolles, R.C. Random sample consensus: A paradigm for model fitting with applications to image analysis and automated cartography. Commun. ACM 1981, 24, 381–395. [Google Scholar] [CrossRef]
  16. Bustos, A.P.; Chin, T.-J. Guaranteed Outlier Removal for Point Cloud Registration with Correspondences. IEEE Trans. Pattern Anal. Mach. Intell. 2018, 40, 2868–2882. [Google Scholar] [CrossRef] [PubMed]
  17. Hu, E.; Sun, L. VODRAC: Efficient and Robust Correspondence-Based Point Cloud Registration with Extreme Outlier Ratios. J. King Saud Univ.-Comput. Inf. Sci. 2023, 35, 38–55. [Google Scholar] [CrossRef]
  18. Sun, L. RANSIC: Fast and Highly Robust Estimation for Rotation Search and Point Cloud Registration Using Invariant Compatibility. IEEE Robot. Autom. Lett. 2022, 7, 143–150. [Google Scholar] [CrossRef]
  19. Chen, Z.; Sun, K.; Yang, F.; Guo, L.; Tao, W. SC2-PCR++: Rethinking the Generation and Selection for Efficient and Robust Point Cloud Registration. IEEE Trans. Pattern Anal. Mach. Intell. 2023, 45, 12358–12376. [Google Scholar] [CrossRef]
  20. Rusu, R.B.; Marton, Z.C.; Blodow, N.; Beetz, M. Persistent Point Feature Histograms for 3D Point Clouds. In Proceedings of the 10th International Conference on Intelligent Autonomous Systems, Baden-Baden, Germany, 23–25 July 2008; pp. 119–128. [Google Scholar]
  21. Salti, S.; Tombari, F.; Di Stefano, L. SHOT: Unique Signatures of Histograms for Surface and Texture Description. Comput. Vis. Image Underst. 2014, 125, 251–264. [Google Scholar] [CrossRef]
  22. Yang, J.; Zhang, Q.; Xiao, Y.; Cao, Z. TOLDI: An Effective and Robust Approach for 3D Local Shape Description. Pattern Recognit. 2017, 65, 175–187. [Google Scholar] [CrossRef]
  23. Zhang, Y.; Li, C.; Guo, B.; Guo, C.; Zhang, S. KDD: A Kernel Density Based Descriptor for 3D Point Clouds. Pattern Recognit. 2021, 111, 107691. [Google Scholar] [CrossRef]
  24. Deng, H.; Birdal, T.; Ilic, S. PPFNet: Global Context Aware Local Features for Robust 3D Point Matching. In Proceedings of the 2018 IEEE/CVF Conference on Computer Vision and Pattern Recognition, Salt Lake City, UT, USA, 18–23 June 2018; pp. 195–205. [Google Scholar]
  25. Deng, H.; Birdal, T.; Ilic, S. PPF-FoldNet: Unsupervised Learning of Rotation Invariant 3D Local Descriptors. In Proceedings of the European Conference on Computer Vision (ECCV), Munich, Germany, 8–14 September 2018; pp. 602–618. [Google Scholar]
  26. Gojcic, Z.; Zhou, C.; Wegner, J.D.; Wieser, A. The Perfect Match: 3D Point Cloud Matching with Smoothed Densities. In Proceedings of the IEEE/CVF Conference on Computer Vision and Pattern Recognition, Long Beach, CA, USA, 15–20 June 2019; pp. 5545–5554. [Google Scholar]
  27. Ao, S.; Hu, Q.; Yang, B.; Markham, A.; Guo, Y. SpinNet: Learning a General Surface Descriptor for 3D Point Cloud Registration. In Proceedings of the IEEE/CVF Conference on Computer Vision and Pattern Recognition, Nashville, TN, USA, 20–25 June 2021; pp. 11753–11762. [Google Scholar]
  28. Vaswani, A.; Shazeer, N.; Parmar, N.; Uszkoreit, J.; Jones, L.; Gomez, A.N.; Kaiser, L.; Polosukhin, I. Attention Is All You Need. In Proceedings of the 31st Conference on Neural Information Processing Systems (NIPS 2017), Long Beach, CA, USA, 4–9 December 2017. [Google Scholar]
  29. Huang, S.; Gojcic, Z.; Usvyatsov, M.; Wieser, A.; Schindler, K. PREDATOR: Registration of 3D Point Clouds with Low Overlap. In Proceedings of the IEEE/CVF Conference on Computer Vision and Pattern Recognition, Nashville, TN, USA, 20–25 June 2021; pp. 4267–4276. [Google Scholar]
  30. Yu, H.; Li, F.; Saleh, M.; Busam, B.; Ilic, S. CoFiNet: Reliable Coarse-to-Fine Correspondences for Robust Point Cloud Registration. Adv. Neural Inf. Process. Syst. 2021, 34, 23872–23884. [Google Scholar]
  31. Qin, Z.; Yu, H.; Wang, C.; Guo, Y.; Peng, Y.; Xu, K. Geometric Transformer for Fast and Robust Point Cloud Registration. In Proceedings of the IEEE/CVF Conference on Computer Vision and Pattern Recognition, New Orleans, LA, USA, 18–24 June 2022; pp. 11143–11152. [Google Scholar]
  32. Li, J.; Hu, Q.; Ai, M. Point Cloud Registration Based on One-Point RANSAC and Scale-Annealing Biweight Estimation. IEEE Trans. Geosci. Remote Sens. 2021, 59, 9716–9729. [Google Scholar] [CrossRef]
  33. Yang, H.; Shi, J.; Carlone, L. TEASER: Fast and Certifiable Point Cloud Registration. IEEE Trans. Robot. 2020, 37, 314–333. [Google Scholar] [CrossRef]
  34. Li, J.; Zhong, R.; Hu, Q.; Ai, M. Feature-Based Laser Scan Matching and Its Application for Indoor Mapping. Sensors 2016, 16, 1265. [Google Scholar] [CrossRef]
  35. Zhou, Q.-Y.; Park, J.; Koltun, V. Fast Global Registration. In Computer Vision–ECCV 2016; Leibe, B., Matas, J., Sebe, N., Welling, M., Eds.; Lecture Notes in Computer Science; Springer International Publishing: Cham, Switzerland, 2016; Volume 9906, pp. 766–782. [Google Scholar]
  36. Li, J.; Zhao, P.; Hu, Q.; Ai, M. Robust Point Cloud Registration Based on Topological Graph and Cauchy Weighted l q -Norm. ISPRS J. Photogramm. Remote Sens. 2020, 160, 244–259. [Google Scholar] [CrossRef]
  37. Lusk, P.C.; Fathian, K.; How, J.P. CLIPPER: A Graph-Theoretic Framework for Robust Data Association. In Proceedings of the 2021 IEEE International Conference on Robotics and Automation (ICRA), Xi’an, China, 30 May–5 June 2021; pp. 13828–13834. [Google Scholar]
  38. Yang, H.; Carlone, L. A Quaternion-Based Certifiably Optimal Solution to the Wahba Problem With Outliers. In Proceedings of the 2019 IEEE/CVF International Conference on Computer Vision (ICCV), Seoul, Republic of Korea, 27 October–2 November 2019; pp. 1665–1674. [Google Scholar]
  39. Zhang, X.; Yang, J.; Zhang, S.; Zhang, Y. 3D Registration with Maximal Cliques. In Proceedings of the IEEE/CVF Conference on Computer Vision and Pattern Recognition, Vancouver, BC, Canada, 17–24 June 2023; pp. 17745–17754. [Google Scholar]
  40. Li, J. A Practical O(N2) Outlier Removal Method for Point Cloud Registration. IEEE Trans. Pattern Anal. Mach. Intell. 2021, 44, 3926–3939. [Google Scholar]
  41. Yao, R.; Du, S.; Cui, W.; Ye, A.; Wen, F.; Zhang, H.; Tian, Z.; Gao, Y. Hunter: Exploring High-Order Consistency for Point Cloud Registration With Severe Outliers. IEEE Trans. Pattern Anal. Mach. Intell. 2023, 45, 14760–14776. [Google Scholar] [CrossRef]
  42. Yan, L.; Wei, P.; Xie, H.; Dai, J.; Wu, H.; Huang, M. A New Outlier Removal Strategy Based on Reliability of Correspondence Graph for Fast Point Cloud Registration. IEEE Trans. Pattern Anal. Mach. Intell. 2022, 45, 7986–8002. [Google Scholar]
  43. Li, R.; Yuan, X.; Gan, S.; Bi, R.; Gao, S.; Luo, W.; Chen, C. An Effective Point Cloud Registration Method Based on Robust Removal of Outliers. IEEE Trans. Geosci. Remote Sens. 2024, 62, 1–16. [Google Scholar] [CrossRef]
  44. Chum, O.; Matas, J.; Kittler, J. Locally Optimized RANSAC. In Pattern Recognition; Michaelis, B., Krell, G., Eds.; Lecture Notes in Computer Science; Springer: Berlin/Heidelberg, Germany, 2003; Volume 2781, pp. 236–243. [Google Scholar]
  45. Barath, D.; Matas, J.; Noskova, J. MAGSAC: Marginalizing Sample Consensus. In Proceedings of the 2019 IEEE/CVF Conference on Computer Vision and Pattern Recognition (CVPR), Long Beach, CA, USA, 15–20 June 2019; pp. 10189–10197. [Google Scholar]
  46. Cavalli, L.; Barath, D.; Pollefeys, M.; Larsson, V. Consensus-Adaptive RANSAC. arXiv 2023, arXiv:2307.14030. [Google Scholar]
  47. Torr, P.H.S.; Zisserman, A. MLESAC: A New Robust Estimator with Application to Estimating Image Geometry. Comput. Vis. Image Underst. 2000, 78, 138–156. [Google Scholar] [CrossRef]
  48. Wu, Y.; Miao, Q.; Ma, W.; Gong, M.; Wang, S. PSOSAC: Particle Swarm Optimization Sample Consensus Algorithm for Remote Sensing Image Registration. IEEE Geosci. Remote Sensing Lett. 2018, 15, 242–246. [Google Scholar] [CrossRef]
  49. Li, J.; Hu, Q.; Ai, M. GESAC: Robust Graph Enhanced Sample Consensus for Point Cloud Registration. ISPRS J. Photogramm. Remote Sens. 2020, 167, 363–374. [Google Scholar] [CrossRef]
  50. Sun, L. ICOS: Efficient and Highly Robust Rotation Search and Point Cloud Registration with Correspondences. arXiv 2021, arXiv:2104.14763. [Google Scholar]
  51. Cheng, Y.; Huang, Z.; Quan, S.; Cao, X.; Zhang, S.; Yang, J. Sampling Locally, Hypothesis Globally: Accurate 3D Point Cloud Registration with a RANSAC Variant. Vis. Intell. 2023, 1, 20. [Google Scholar] [CrossRef]
  52. Gentner, M.; Kumar Murali, P.; Kaboli, M. GMCR: Graph-Based Maximum Consensus Estimation for Point Cloud Registration. In Proceedings of the 2023 IEEE International Conference on Robotics and Automation (ICRA), London, UK, 29 May 2023; pp. 4967–4974. [Google Scholar]
  53. Chung, K.-L.; Chang, W.-T. Centralized RANSAC-Based Point Cloud Registration With Fast Convergence and High Accuracy. IEEE J. Sel. Top. Appl. Earth Obs. Remote Sens. 2024, 17, 5431–5442. [Google Scholar] [CrossRef]
  54. Horn, B.K.P. Closed-Form Solution of Absolute Orientation Using Unit Quaternions. J. Opt. Soc. Am. A 1987, 4, 629. [Google Scholar] [CrossRef]
  55. Arun, K.S.; Huang, T.S.; Blostein, S.D. Least-squares fitting of two 3-d point sets. IEEE Trans. Pattern Anal. Mach. Intell. 1987, 5, 698–700. [Google Scholar] [CrossRef]
  56. Han, W.; Tat-Jun, C.; Suter, D. Simultaneously Fitting and Segmenting Multiple-Structure Data with Outliers. IEEE Trans. Pattern Anal. Mach. Intell. 2012, 34, 1177–1192. [Google Scholar]
  57. Lai, T.; Wang, H.; Yan, Y.; Chin, T.-J.; Zheng, J.; Li, B. Accelerated Guided Sampling for Multistructure Model Fitting. IEEE Trans. Cybern. 2020, 50, 4530–4543. [Google Scholar] [CrossRef] [PubMed]
  58. Zeng, A.; Song, S.; Niessner, M.; Fisher, M.; Xiao, J.; Funkhouser, T. 3DMatch: Learning Local Geometric Descriptors from RGB-D Reconstructions. In Proceedings of the 2017 IEEE Conference on Computer Vision and Pattern Recognition (CVPR), Honolulu, HI, USA, 21–26 July 2017; pp. 199–208. [Google Scholar]
  59. Geiger, A.; Lenz, P.; Urtasun, R. Are We Ready for Autonomous Driving? The KITTI Vision Benchmark Suite. In Proceedings of the 2012 IEEE Conference on Computer Vision and Pattern Recognition, Providence, RI, USA, 16–21 June 2012; pp. 3354–3361. [Google Scholar]
  60. Besl, P.J.; McKay, N.D. A Method for Registration of 3-D Shapes. IEEE Trans. Pattern Anal. Mach. Intell. 1992, 14, 239–256. [Google Scholar] [CrossRef]
  61. Krishnamurthy, V.; Levoy, M. Fitting smooth surfaces to dense polygon meshes. In Proceedings of the 23rd Annual Conference on Computer Graphics and Interactive Techniques, New Orleans, LA, USA, 4–9 August 1996; pp. 313–324. [Google Scholar]
  62. Wei, P.; Yan, L.; Xie, H.; Huang, M. Automatic Coarse Registration of Point Clouds Using Plane Contour Shape Descriptor and Topological Graph Voting. Autom. Constr. 2022, 134, 104055. [Google Scholar] [CrossRef]
  63. Yang, J.; Xiao, Y.; Cao, Z.; Yang, W. Ranking 3D Feature Correspondences via Consistency Voting. Pattern Recognit. Lett. 2019, 117, 1–8. [Google Scholar] [CrossRef]
  64. Sipiran, I.; Bustos, B. Harris 3D: A Robust Extension of the Harris Operator for Interest Point Detection on 3D Meshes. Vis. Comput. 2011, 27, 963–976. [Google Scholar] [CrossRef]
  65. Bai, X.; Luo, Z.; Zhou, L.; Chen, H.; Li, L.; Hu, Z.; Fu, H.; Tai, C.-L. PointDSC: Robust Point Cloud Registration Using Deep Spatial Consistency. In Proceedings of the 2021 IEEE/CVF Conference on Computer Vision and Pattern Recognition (CVPR), Nashville, TN, USA, 20–25 June 2021; pp. 15854–15864. [Google Scholar]
  66. Choy, C.; Park, J.; Koltun, V. Fully Convolutional Geometric Features. In Proceedings of the 2019 IEEE/CVF International Conference on Computer Vision (ICCV), Seoul, Republic of Korea, 27 October–2 November 2019; pp. 8957–8965. [Google Scholar]
Figure 1. Overview of the proposed method. First, taking the initial correspondences as inputs, the compatibility graph is constructed by calculating the compatibility of each correspondence with other correspondences. Then the minimum compatible subset is constructed by combining compatible edge sampling and candidate vertex sampling, model hypotheses are generated, preference scores for model hypotheses are computed for each correspondence, and similarity matrices are further constructed to select the set of possible inliers to participate in the subsequent iterations. Finally, the transformation parameters are calculated based on the maximum consensus set obtained from the iterations, and the registration is completed using the transformation parameters.
Figure 1. Overview of the proposed method. First, taking the initial correspondences as inputs, the compatibility graph is constructed by calculating the compatibility of each correspondence with other correspondences. Then the minimum compatible subset is constructed by combining compatible edge sampling and candidate vertex sampling, model hypotheses are generated, preference scores for model hypotheses are computed for each correspondence, and similarity matrices are further constructed to select the set of possible inliers to participate in the subsequent iterations. Finally, the transformation parameters are calculated based on the maximum consensus set obtained from the iterations, and the registration is completed using the transformation parameters.
Remotesensing 16 02789 g001
Figure 2. The generation of simulation data, where green lines denote the inliers while red lines denote the outliers, and the bolded points indicate key points: (a) Key points, (b) 20% outliers are added, (c) 60% outliers are added, (d) 90% outliers are added, and (e) 99% outliers are added.
Figure 2. The generation of simulation data, where green lines denote the inliers while red lines denote the outliers, and the bolded points indicate key points: (a) Key points, (b) 20% outliers are added, (c) 60% outliers are added, (d) 90% outliers are added, and (e) 99% outliers are added.
Remotesensing 16 02789 g002
Figure 3. Influence of the parameters b and max_up on the performance of proposed method: (a) Rotation error for sensitivity test of b, (b) translation error for sensitivity test of b, (c) running time for sensitivity test of b, (d) rotation error for sensitivity test of max_up, (e) translation error for sensitivity test of max_up, (f) running time for sensitivity test of max_up.
Figure 3. Influence of the parameters b and max_up on the performance of proposed method: (a) Rotation error for sensitivity test of b, (b) translation error for sensitivity test of b, (c) running time for sensitivity test of b, (d) rotation error for sensitivity test of max_up, (e) translation error for sensitivity test of max_up, (f) running time for sensitivity test of max_up.
Remotesensing 16 02789 g003aRemotesensing 16 02789 g003b
Figure 4. Registration performance on simulated data. In the figure, ▌ indicates data between 25% and 75% of all data in the result in descending order of magnitude; I indicates maximum and minimum values; - indicates average value; ◆ denotes outliers: (a) Box-plot of rotation error. (b) Box-plot of translation error. (c) Box-plot of time cost.
Figure 4. Registration performance on simulated data. In the figure, ▌ indicates data between 25% and 75% of all data in the result in descending order of magnitude; I indicates maximum and minimum values; - indicates average value; ◆ denotes outliers: (a) Box-plot of rotation error. (b) Box-plot of translation error. (c) Box-plot of time cost.
Remotesensing 16 02789 g004
Figure 5. Visualization results on synthetic dataset, where blue points indicate source point cloud. green lines and green points denote the inliers while red lines and red points denote the outliers: (a) Correspondences with 60% outliers, (b) Registration result of (a), (c) Correspondences with 99% outliers, (d) Registration result of (c).
Figure 5. Visualization results on synthetic dataset, where blue points indicate source point cloud. green lines and green points denote the inliers while red lines and red points denote the outliers: (a) Correspondences with 60% outliers, (b) Registration result of (a), (c) Correspondences with 99% outliers, (d) Registration result of (c).
Remotesensing 16 02789 g005
Figure 6. Initial correspondences for different scenarios, where green lines denote the inliers while red lines denote the outliers, blue points and red points indicate the source and target point clouds, and the bolded points indicate key points: (a) Kitchen, inliers/totals: 21/1876. (b) Home1, inliers/totals: 23/2682. (c) Home2, inliers/totals: 20/2494. (d) Hotel1, inliers/totals: 27/1947. (e) Hotel2, inliers/totals: 21/2167. (f) Hotel3, inliers/totals: 20/3044. (g) Studyroom, inliers/totals: 20/1500. (h) Lab, inliers/totals: 20/1359.
Figure 6. Initial correspondences for different scenarios, where green lines denote the inliers while red lines denote the outliers, blue points and red points indicate the source and target point clouds, and the bolded points indicate key points: (a) Kitchen, inliers/totals: 21/1876. (b) Home1, inliers/totals: 23/2682. (c) Home2, inliers/totals: 20/2494. (d) Hotel1, inliers/totals: 27/1947. (e) Hotel2, inliers/totals: 21/2167. (f) Hotel3, inliers/totals: 20/3044. (g) Studyroom, inliers/totals: 20/1500. (h) Lab, inliers/totals: 20/1359.
Remotesensing 16 02789 g006aRemotesensing 16 02789 g006b
Figure 7. The visual performance of real-world data experiment of algorithms, where yellow and cyan indicate the source and target data.
Figure 7. The visual performance of real-world data experiment of algorithms, where yellow and cyan indicate the source and target data.
Remotesensing 16 02789 g007
Figure 8. Registration performance on 3DMatch dataset. In the figure, ▌ indicates data between 25% and 75% of all data in the result in descending order of magnitude; I indicates maximum and minimum values; - indicates average value; ◆ denotes outliers: (a) Box-plot of rotation error. (b) Box-plot of translation error. (c) Box-plot of time cost.
Figure 8. Registration performance on 3DMatch dataset. In the figure, ▌ indicates data between 25% and 75% of all data in the result in descending order of magnitude; I indicates maximum and minimum values; - indicates average value; ◆ denotes outliers: (a) Box-plot of rotation error. (b) Box-plot of translation error. (c) Box-plot of time cost.
Remotesensing 16 02789 g008
Figure 9. Visualization of two groups of point cloud registration results on the 3DLoMatch, where yellow and cyan indicate the source and target data. The upper group has an overlap rate of 11.14% and the lower group has an overlap rate of 11.98%. From left to right: results of LGR, RANSAC, GROR, RANSIC, ours, and ground truth. RANSAC fails for the data pair in the first row, while other algorithms successfully align these data pairs.
Figure 9. Visualization of two groups of point cloud registration results on the 3DLoMatch, where yellow and cyan indicate the source and target data. The upper group has an overlap rate of 11.14% and the lower group has an overlap rate of 11.98%. From left to right: results of LGR, RANSAC, GROR, RANSIC, ours, and ground truth. RANSAC fails for the data pair in the first row, while other algorithms successfully align these data pairs.
Remotesensing 16 02789 g009
Figure 10. Visualization results on KITTI, where yellow and blue indicate the source and target data. From left to right: results of LGR, RANSAC, GROR, RANSIC, ours, and ground truth. All algorithms successfully align the data pairs.
Figure 10. Visualization results on KITTI, where yellow and blue indicate the source and target data. From left to right: results of LGR, RANSAC, GROR, RANSIC, ours, and ground truth. All algorithms successfully align the data pairs.
Remotesensing 16 02789 g010
Table 1. Detailed Settings of the Compared Algorithms.
Table 1. Detailed Settings of the Compared Algorithms.
MethodParameters
RANSACMaximum number of iterations: 105; inlier threshold: 6pr
GORELower bound: 0; repeat: true; consistent threshold: 6pr
One-Point RANSACConfidence: 0.99; subset size: 1;
Maximum number of iterations: 105; step size: 1.3
GRORreliable set size: 800; inlier threshold: 6pr
RANSICMaximum number of iterations: 105; Confidence: 0.99
VODRACMaximum number of iterations: 105; Confidence: 0.99; inlier threshold: 6pr
OursMaximum number of iterations: 105; inlier threshold: 6pr
P1 = P2 = 0.99; b = 20; max_up = 3; δ = 10pr; ξ = 10−6
Table 2. Quantitative results on 3DMatch dataset.
Table 2. Quantitative results on 3DMatch dataset.
KitchenHome1Home2Hotel1Hotel2Hotel3StudyroomLab
Mean outlier ratio 98.55%98.74%98.70%98.96%98.93%98.83%98.69%98.74%
Mean Rotation Error (°)
RANSAC60.85470.98486.46560.23772.17270.02886.58471.358
GORE56.38962.74565.34242.88538.99847.64542.73289.329
One-Point RANSAC50.12865.93979.37944.53345.15145.93045.53372.256
GROR14.3826.92019.6859.1350.9437.84224.88612.356
RANSIC1.7941.1731.1891.1330.9841.0291.0791.022
VODRAC1.3951.0401.0040.8420.9491.0471.1941.142
Ours1.1470.9090.9990.7370.9330.9311.1220.921
Mean Translation Error (m)
RANSAC1.48041.87291.96351.81191.76251.72332.11612.8324
GORE1.55562.10002.10681.74911.88691.88291.42612.5204
One-Point RANSAC1.10901.67282.19701.19210.93291.00321.46401.8214
GROR0.25620.28260.55060.26870.03160.23860.62350.3536
RANSIC0.04720.04690.04940.04900.04060.04170.04630.0540
VODRAC0.03270.03210.03330.03020.03150.03570.03860.0461
Ours0.02010.03270.03390.03040.03260.03270.03620.0407
Mean Time Cost (s)
RANSAC3.3984.9676.4268.3897.4578.2764.13411.439
GORE0.4691.6971.8670.9210.4941.3701.6182.154
One-Point RANSAC0.2990.3540.3640.4340.4320.4300.2830.446
GROR2.7783.5543.3324.0693.8283.8572.8293.494
RANSIC69.00157.093151.787182.039183.542119.140116.414326.279
VODRAC1.9832.6432.7733.3003.2463.2602.0132.989
Ours0.7591.1291.1210.9481.1550.8260.8042.001
Table 3. Registration results on 3DLoMatch with learning-based correspondences.
Table 3. Registration results on 3DLoMatch with learning-based correspondences.
Method E ¯ R   (°) E ¯ t   (m)RR (%)
LGR2.9920.086777.50
RANSAC4.5160.138561.93
GROR3.1860.101280.85
RANSIC3.5490.114379.79
Ours2.9670.096280.91
Table 4. Registration results on KITTI with learning-based correspondences.
Table 4. Registration results on KITTI with learning-based correspondences.
Method E ¯ R   (°) E ¯ t   ( m ) RR (%)
LGR0.3780.069399.10
RANSAC0.8030.186198.38
GROR0.5050.128797.84
RANSIC0.3850.087299.10
Ours0.3410.080499.10
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.

Share and Cite

MDPI and ACS Style

Wang, C.; Zheng, Z.; Zha, B.; Li, H. Fast Robust Point Cloud Registration Based on Compatibility Graph and Accelerated Guided Sampling. Remote Sens. 2024, 16, 2789. https://doi.org/10.3390/rs16152789

AMA Style

Wang C, Zheng Z, Zha B, Li H. Fast Robust Point Cloud Registration Based on Compatibility Graph and Accelerated Guided Sampling. Remote Sensing. 2024; 16(15):2789. https://doi.org/10.3390/rs16152789

Chicago/Turabian Style

Wang, Chengjun, Zhen Zheng, Bingting Zha, and Haojie Li. 2024. "Fast Robust Point Cloud Registration Based on Compatibility Graph and Accelerated Guided Sampling" Remote Sensing 16, no. 15: 2789. https://doi.org/10.3390/rs16152789

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop