Next Article in Journal
Global Optimization in Robust Fractional Control of Uncertain Fractional Order Systems: A Thermal Application Using the STM32 Microcontroller
Previous Article in Journal
Fourier Image Watermarking: Print-Cam Application
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

A Coarse-to-Fine Registration Approach for Point Cloud Data with Bipartite Graph Structure

1
Hefei Institute of Physical Science, Chinese Academy of Sciences, Hefei 230031, China
2
Science Island Branch, Graduate School of USTC, Hefei 230026, China
*
Authors to whom correspondence should be addressed.
Electronics 2022, 11(2), 263; https://doi.org/10.3390/electronics11020263
Submission received: 9 December 2021 / Revised: 10 January 2022 / Accepted: 12 January 2022 / Published: 14 January 2022
(This article belongs to the Section Computer Science & Engineering)

Abstract

:
Alignment is a critical aspect of point cloud data (PCD) processing, and we propose a coarse-to-fine registration method based on bipartite graph matching in this paper. After data pre-processing, the registration progress can be detailed as follows: Firstly, a top-tail (TT) strategy is designed to normalize and estimate the scale factor of two given PCD sets, which can combine with the coarse alignment process flexibly. Secondly, we utilize the 3D scale-invariant feature transform (3D SIFT) method to extract point features and adopt fast point feature histograms (FPFH) to describe corresponding feature points simultaneously. Thirdly, we construct a similarity weight matrix of the source and target point data sets with bipartite graph structure. Moreover, the similarity weight threshold is used to reject some bipartite graph matching error-point pairs, which determines the dependencies of two data sets and completes the coarse alignment process. Finally, we introduce the trimmed iterative closest point (TrICP) algorithm to perform fine registration. A series of extensive experiments have been conducted to validate that, compared with other algorithms based on ICP and several representative coarse-to-fine alignment methods, the registration accuracy and efficiency of our method are more stable and robust in various scenes and are especially more applicable with scale factors.

1. Introduction

With the rapid development of optical measurement technology, three-dimensional (3D) models of real-world objects with different views have been employed to collect data for many application scenarios [1,2,3,4,5]. As the fundamental technique in 3D data processes, the registration method is mainly responsible for determining the correspondence and transformation of multiple-view 3D data, which facilitates the implementation of many reverse engineering applications, such as multi-platform data alignment for airborne and terrestrial laser scanning [6], foot alignment for reconstruction in the footwear consumer field [7], remote sensing image registration in military and civilian fields [8], skull registration for craniofacial reconstruction in the medical field [9], cross-source point cloud registration in large-scale scanned data for street views outdoors [10], 3D face registration for face recognition [11], etc. During the past few decades, the high-performance registration method has become an increasingly important research topic. However, the existing registration algorithms still have many defects in terms of efficiency and accuracy in practice. According to the transformation relationship of different-view 3D data, registration methods can be divided into rigid registration algorithms and non-rigid registration algorithms. In this paper, we mainly focus on rigid alignment methods with some extensibility, and all processed 3D data is PCD.
As the best-known registration algorithm, ICP conducts an iterative process to align the relatively similar 3D point clouds well with constraint conditions of uniform density, high overlap rate and good initial position, and it is prone to trap into local optimal problems [12,13]. Multiple ICP variants have also been proposed to improve performance. Trimmed ICP (TrICP) utilizes the Least-Trimmed Squares approach to improve robustness in low data overlaps [14]. Generalized ICP(GICP) designs a structure by minimizing the plane-to-plane distance to enhance the resistance to noise [15]. Globally Optimal ICP (Go-ICP) provides a globally optimal Euclidean solution under L 2 error with a branch-and-bound scheme to avoid local optimization [16]. Multi-resolution ICP (MRICP) incorporates a hierarchical octree for data multi-resolution spatial partitioning to speed up computation and enhance robustness [17]. Markov chain Monte Carlo simulated annealing (MCMC-SA) ICP combined an MCMC method and an improved SA method to accelerate convergence with the global minimum [18]. Although ICP-based algorithms achieve high registration accuracy, the iterative computational approach and good initial position condition restriction limit their applications in practical 3D data processing.
Probability distribution alignment (PDA) methods regard the registration problem as a probability density estimation problem and have good robustness in noise and different data overlap rates. The Normal Distributions Transform (NDT) utilizes a Gaussian probability distribution to represent each point and completes the alignment by maximizing the sum of the Gaussian probability distributions of transformed unregistered PCD [19]. Coherent Point Drift (CPD) fits the Gaussian mixture model (GMM) centroids of target PCD to source PCD through estimating the maximum likelihood [20]. Student’s t latent mixture model (TLMM) constructs a hierarchical Bayesian network to algin different PCD based on student-t mixture model (SMM), which effectively improves the robustness [21]. Among these PDA algorithms, some have lower accuracy with fast registration speed, such as NDT, and conversely, high-performance methods (CPD and TLMM are also applicable for non-rigid alignment) utilize EM iterative algorithms to solve the optimization of the objective function, which cannot avoid large computational and local optimization problems.
In recent years, the PCD registration research based on deep learning framework has gradually attracted the attention of scholars. The Deep Closest Point (DCP) predicts a rigid transformation for two PCD from a deep learning perspective [22]. A Deep Gaussian Mixture Registration (DeepGMR) model designs a neural network to search GMM parameters and computation blocks to obtain optimal transformation [23]. As a data-driven model, 3DMatch learns local volumetric patch descriptors for establishing 3D data correspondences during the rough registration phase [24]. The Robust Point Matching (RPM)-Net confirms point correspondences with differentiable Sinkhorn layers and estimates optimal annealing parameters with the second network [25]. These algorithms have good performance in alignment robustness, accuracy and large data. However, the majority of deep learning methods suffer from heavy memory resources, which limits the generality of application.
The coarse-to-fine alignment algorithms are the most widely used non-rigid registration methods. At first, common coarse alignment algorithms, such as Random Sample Consensus (RANSAC) [26], 4-Points Congruent Sets (4PCS) [27], Principal Component Analysis (PCA) [28], etc., perform fast rough position transformation estimation by randomly selecting some points with distance constraints or downscaled processing. The fine alignment algorithms, such as ICP and its variants, conduct further transformation computation of two PCD on the basis of previous initial transformation correspondence, which greatly reduces the iterative computation. However, the results of these coarse registration methods may be unstable and have a large error, which sometimes imposes a greater burden for the fine alignment process. Then, the coarse registration methods utilize similarity measures of local feature points and descriptors to determine the initial transformation correspondence. SAmple Consensus Initial Alignment (SAC-IA) utilizes Fast Point Feature Histograms (FPFH) local geometry descriptors to match points in different point clouds [29]. Keypoint-based 4PCS (K4PCS) adopts 3D Difference-of-Gaussians or 3D Harris corner detector to extract key points and then performs coarse alignment instead of raw PCD to improve computation efficiency and accuracy [30]. The enhanced performance of coarse alignment algorithms contributes to the application of coarse-to-fine registration methods. Liu et al. [31] utilized FPFH features to find corresponding point pairs, RANSAC to eliminate initial incorrect correspondence and NDT to refine the transformation. Li et al. [32] proposed a graph-enhanced sample consensus (GESAC) to estimate rough transformation with robust shape-annealing, which improved RANSAC-based fine registration accuracy. Although these methods show good alignment performance, the nature of local feature point extraction is prone to interference from noise and inhomogeneous density. Shi et al. [33] adopted a PDA model of NDT to compute the initial transformation matrix, where ICP performs the fine alignment, which improves the robustness of the alignment algorithm to noise. Currently, the top state-of-art coarse-to-fine registration methods summarize the results of continuous optimization of rough alignment and ICP. Wu et al. [34] designed a coarse-to-fine registration algorithm based on FPFH eigenvalue and volume constraints. This algorithm can reduce mismatch rate and improves the point cloud registration precision with ICP. Lu et al. [35] proposed a point cloud registration algorithm combined with improved K4PCS and ICP to improve the speed and accuracy. Wu et al. [36] presented a triangular model registration algorithm based on differential topological singularity points (DTSP)-ICP. This algorithm is able to obtain the mesh model nature of differential topological structure and avoid local errors based on Euclidean distance. Shi et al. [33] utilized SAC-IA to conduct rough alignment and perform fine registration with NDT and ICP, respectively. According to their research, SAC + ICP has better performance. Yao et al. [37] proposed an improved iterative closest point (ICP) algorithm based on the curvature feature similarity. PCA was used to confirm a better initial value, and the similarity of curvature features was used to determine the nearest points for fine registration. Kamencay et al. [38] presented an improved feature-based registration algorithm to reduce time consumption and improve ICP convergence speed, with the combination of 3D scale-invariant feature transform (SIFT) key-point extraction and K-nearest neighbor (KNN) clusters. Xu et al. [39] designed a fast point cloud registration algorithm combined with intrinsic shape signatures (ISS) detector, 3D shape context (3DSC) descriptor, RANSAC and an improved ICP method. The ISS key points described by 3DSC were used for rough alignment with RANSAC, and ICP conducted accurate registration. Wen et al. [9] proposed a hierarchical coarse-to-fine alignment method for skull registration. The improved spin image and k-means algorithm rough stage were used in the rough stage. The advanced ICP algorithm improved performance in point sampling and mismatched point elimination. Wang et al. [40] introduced a coarse-to-fine trimmed strategy with Generalized Iterative Closest Point (GICP) algorithm. This algorithm implemented an inner iteration process and outer strategy to refine the match results. Through various improvements and optimizations, the robustness, accuracy and speed of the coarse-to-fine algorithms have been improved. The coarse-to-fine alignment methods based on local feature points and descriptors are still very competitive. However, these methods do not take global characteristics into consideration, which still easily increases the mismatching rate. This paper is dedicated to proposing a rough alignment method that combines local features with global characteristics assignment and adopts TrICP to complete the subsequent fine alignment process.
Moreover, the general rigid registration methods will fail in point sets with scale factors, while the scale factor is easily produced by scanning data with different resolutions or multi-perspective distance. Several pioneering works have been proposed to extend rigid registration algorithms to the isotropic scale case. Zha et al. [41] computed the scale with extended signature images (ESIs) correspondence and applied it to ICP. Du et al. [42] integrated a bounded scale into ICP. Ying et al. [43] incorporated a scale factor into ICP and iteratively searched for the optimal solution to register data sets with isotropic stretches. Du et al. [44] provided a new isotropic scaling ICP algorithm with the corner point constraint adding to the objective function. Huang et al. [10] presented a coarse-to-fine algorithm to register two cross-source PCD and the estimated scale value with the same GMM mode during the fine registration phase. Wang et al. [40] estimated the isotropic scale factor by solving a point-to-point distance optimization function. Yang et al. [45] proposed a new objective function to compute similarity and affine transformation parameters (including a scale factor) based on a bidirectional kernel mean p-power error (KMPE) loss. In these methods, the scale factor is estimated within the iterative solving process of the objective function, which inevitably leads to complex computational problems. Huang et al. [46] implemented an independent scale normalization process for cross-source PCD registration. Motivated by this method, we have designed a pluggable top-tail (TT) strategy with few computations to extend the proposed coarse-to-fine registration algorithm in isotropic scale scenes. Table 1 compares the computation amount, flexibility and extensibility of the above-mentioned methods.
To the best of our knowledge, the proposed method is an effective solution in two-PCD alignment with poor initial positions and an isotropic scale factor solution. The key to this achievement is the combination of scale factor estimation, local feature points extraction and description, global point pairs correspondence determination and fine registration.
Thus, the main contributions of this paper are as follows:
  • TT strategy. Top-tail strategy is an independent and pluggable component, which is designed to be easily and flexibly combined with a variety of existing coarse alignment methods, rather than involved in complex optimum computation. This strategy consists of a normalization operation and a scaling factor estimation process. The normalization operation occurs before the coarse alignment process, and the scaling factor estimation occurs after the coarse registration. The normalization operation adjusts the two data sets to the same scale coordinate system. The coarse alignment results of the normalized original and target datasets contain a rotation matrix, according to which the normalized source object is corrected. Then, a boundary most-value ratio operation is utilized to estimate the scaling factor value based on corrected data sets. The rotated, scale-adjusted source PCD and target PCD are used as input objects for further fine registration.
  • Bipartite graph matching scheme. Based on local features and descriptors of key points, bipartite graph matching is adopted to determine the initial correspondence from a global perspective. The bipartite graph structure is utilized to store feature descriptor similarity and a key-points index. Moreover, the weight between bipartite graph nodes should be recorded as the ratio of feature descriptor similarity above the pre-set threshold value. Through the Hungarian algorithm, the maximum set of matching feature points forms the initial correspondence pairs.
The rest of this paper is organized as follows: We present the preliminaries throughout this paper in Section 2. Section 3 details the specific implementation process of the registration approach proposed in this paper. The experimental performance evaluation is conducted in Section 4. Conclusions and discussions are carried out in Section 5.

2. Preliminaries

In this section, we review some of the relevant background knowledge and related knowledge that will be used in this paper.

2.1. 3D SIFT

The 3D SIFT describes local features with the ability to resist the influence of viewing angle changes, noise interference, brightness changes, affine transformations and rotation transformations, which are explored in the difference of Gaussian (DOG) pyramid [47]. At first, a Gaussian pyramid is built through a voxelized point cloud with scale ε , and the scale space L ( X , ε ) can be obtained from the convolution of Gaussian blur kernel G ( X , ε ) with 3D image, as described in (1).
L ( X , ε ) = G ( X , ε ) * Q ( X ) G ( X , ε ) = e | | X | | 2 2 ε 2 ( 2 π ε ) 3 D O G ( X i , ε j + 1 ) = L ( X i , ε j + 1 ) L ( X i , ε j )
where X denotes 3D coordinates ( x , y , z ) .
Then, a series of octaves with different scales should be generated. For every scale ε , two adjacent scales can be described as (2).
ε i + 1 = k ε i ,   ε 0 = k 1 ε m i n ,   ( i = 0 , 1 , , ξ + 2 )
To detect local extreme values in the DOG pyramid, nearest k-neighborhood points are compared with the query point. The points with minima or maxima DOG values are regarded as 3D SIFT key points.

2.2. FPFH Descriptor Estimation

The FPFH descriptor is an improved version of the PFH descriptor, which is computed as a histogram of geometric properties at a point P [29]. Within the range of middle point P C with radius r , the computation is based on the estimated angle and positional relationship between normal vectors n s and n t for the nearest k neighbors point pair P s and P t . Figure 1 presents the relationship of two points in UVW local coordinate system. The U ,   V , W and parameters ( α , β , θ ) are calculated as (3):
.
{ U = n s                                 V = U × ( P t P s ) P t P s 2             W = U × V                           α = V   n s                             β = U ( P t P s ) P t P s 2                   θ = arctan ( W n s , U n t )   ,
where α , β and θ of k-neighborhood point pairs constitute triplets.
Each triplet feature value need be separated into some subdivisions, of which the number of occurrences should be recorded as the histogram description. Compared with PFH, the FPFH descriptor reduces the computation complexity from O(nk2) to O(nk): (1) FPFH increases neighborhood selection range from r to 2r, which also includes the neighborhood of all points in the neighborhood; (2) FPFH only computes the relationships of point and its k-neighborhood to form the simplified point feature histograms (SPFH). The neighboring values of SPFH are utilized to weight the final histogram, as computed in (4):
F P F H ( P ) = S P F H ( P ) + 1 k i = 1 k 1 W i g h t i S P F H ( P i )

2.3. Bipartite Graph Matching

A weighted bipartite graph structure G = { N   V , E , W } contains two types of vertices ( N —the set of nodes ( { n 1 , n 2 , , n m } ), V —the set of nodes ( { v 1 , v 2 , , v m } )), edges E { N × V } and W —the weight matrix ( { w 11 , w 12 , , w m m } ). For e i j E , each edge carries a weight w i j that represents the connection strength between n i and v i , where i and j denote the i-th and j-th vertices in N and V . If edge subset M E and no two edges in M share a common vertex incident to them, the M should be regarded as a match. Moreover, if | M | = | N | = | V | , the M is a perfect match. The Kuhn−Munkres (KM) theorem is used to find a perfect matching of weighted complete bipartite graph [48]. The KM algorithm transforms the weights and sets an initial benchmark at each vertex of the X-set and Y-set. Then, the greedy algorithm preferentially selects the edge with the largest weight for matching. When there is another one where the largest edges of the two X vertices have the same Y vertex, the selected complete benchmark needs to be adjusted to form a new matching subgraph with largest weight. Finally, when an equal subgraph is found, the corresponding maximum weight matching is found.

2.4. TrICP Algorithm

Based on the least-squares (LS) optimal matching idea, the ICP algorithm puts the source cloud points P = { p j | j = 1 , , n } into the frame of the target point set Q = { q i | i = 1 , , m } to obtain consistent point cloud. As followed in (5), to repeat the calculation of optimal rigid body transformation until the convergence criterion is satisfied or the preset number of iterations is reached, the ICP algorithm can obtain a good estimate of the rotation R and the translation T .
F ( R , T ) = 1 m i = 1 m | | q i R k p j k 1 T k | | 2 ,     ( 1 j n ) M E k = 1 m i = 1 m | | q i k p i k 1 | |
where k is the iteration number, ME denotes the mean error after the k-th iteration computation, and the value of | |   M E k M E k 1 | | represents the preset convergence value.
As an optimization variant of ICP, TrICP utilizes the overlap ratio for points matching and Least-Trimmed Squares (LTS) to enhance the robustness for noise [14]. The pre-set overlap rate between the source point cloud P and the target point cloud Q is γ . The corresponding points number n c can be described as n c =   γ n . TrICP reserves n c pairs of points that satisfy the overlap ratio after distance ordering by LTS and searches the transformation matrix by Singular Value Decomposition (SVD) method, as shown in (6).
d i 2 ( R , T ) = a r g m i n q p i ( R , T ) p i ( R , T ) 2 , d 1 2 d 2 2 d 3 2 d n c 2 S u m d i = i = 1 n c d i : n c 2 M S E = S u m d i / n c
where d i 2 represents squared distance value of the i-th point pair, S u m d i is the sum of n c   d i 2 value, and M S E is the termination condition of the iterative computation.

3. The Proposed Coarse-to-Fine Registration Method Overview

In this section, we detail the coarse-to-fine registration algorithm based on bipartite graph perfect matching for scaled 3D data. The design scheme of proposed registration algorithm described in Figure 2 contains four phases: data pre-processing, TT strategy, coarse alignment and fine registration. The specific steps of these phases include filter process, point cloud normalization process, key points extraction, FPFH descriptor presentation, bipartite graph construction, correspondence point pair confirmation, initial rotation matrix estimation, scale factor estimation and fine registration.

3.1. Data Pre-Processing

Data pre-processing of PCD registration workflows mainly eliminates noise, which is essential for subsequent alignment processing. In this paper, the raw sampled 3D face data is scanned from depth camera RealSense with different views, which cannot be processed directly due to inevitable noise and outliers caused by a device’s inherent noise, object surface characteristics and object reflection [49]. Based on our previous study [7] and research [50], a hierarchical filter specifically designed for depth image point cloud is presented. Since the 3D model in the public library, such as the bunny rabbit, dragon and scanned room from an open-source library used in Section 4, does not involve the noise problem of sampling equipment, the ability of this filter should degenerate to a Gaussian filter. The solution of noise filtering in the acquisition process of non-depth camera equipment is not within the scope of this paper.
  • Range filter. In the multi-view scene, the noise is mainly generated by the background because each scanning device will capture the opposite one or bracket. In this level, the filter performs a wide range and coarse-grained filtering by removing invalid points with a depth value of 0.
  • Gray image segmentation filter. For large-scale outlier noise, to compute the threshold of target and background in an IR image obtained directly from the camera, the outliers are eliminated with a mathematical morphological opening operation in binary image converted from IR image. Regard the new binary image as an index map to filter the 3D point cloud.
  • Gaussian filter. The Gaussian filter is utilized to remove small-scale noise points (when the density is less than the threshold value) located inside or at the boundary of point cloud sets. The k neighborhood points around each point cloud are searched in turn, and the average Euclidean distance of the sampled point to its k neighborhood points can be calculated. The distances of all points in the point cloud should form a Gaussian distribution, and the noise reduction can be achieved by providing the mean and variance value.

3.2. Top-Tail Strategy

To solve the problem of PCD alignment for the scale variation, the TT strategy, including normalization computation and scale estimation, has been designed to flexibly nest with multiple coarse alignment algorithms to adjust the initial position and scale factors of unregistered point cloud objects.
  • Normalization Computation. As scale factors should improve the difficulty for the point cloud registration process, we firstly normalize the PCD for the subsequent coarse alignment to be proceed smoothly. The scale-adjusted problem can be described as (5) by extending (7):
    F ( S , R , T ) = 1 m i = 1 m | | q i S R p j T | | 2 ,     ( 1 j n )
    where S is the scale factor.
    Inspired by [46], the normalization process computes the maximum component of different dimensions and then calculates the proportion in different dimensions for each point, as described in (8).
    C P n o r ( x , y , z ) = C P ( x i , y i , z i ) C P ( x , y , z ) m i n C P ( x , y , z ) m a x C P ( x , y , z ) m i n  
    where C P ( x , y , z ) denotes the coordinate values of points in the point cloud, i is the i-th index of points, label n o r denotes the normalized value of points, label m a x is the maximum value of points, and label m i n is the minimum value of points.
    Through the normalization process, the effect of translation and scale can be eliminated, and (7) can be simplified to (9).
    F ( R ) = 1 m i = 1 m | | q i R p j | | 2 ,     ( 1 j n )
  • Scale estimation. To remove scale variation, the source point cloud P needs to be rotated with R (computed from coarse alignment) to obtain the PR set. Then, the maximum distance of PR points and Q points should be calculated, respectively. The scale can be computed by comparing these two maximum distances as (10).
    s c a l e = | | Q m a x Q m i n | | | | P R m a x P R m i n | |
    Through this method, we cannot deal with the scale problem completely. However, the adjusted PCD is sufficient for the fine registration since most of the scale difference is eliminated.

3.3. The Coarse Registration

In the coarse alignment phase, the most important solution is to find the correspondent key point set. Instead of regarding points with smallest distance between the FPFH local feature descriptors as a matching set, the KM method is utilized to confirm the point set correspondence globally, which is used for initial rotation matrix estimation.
  • Feature points extraction and description. In order to improve processing efficiency caused by a large amount of 3D data, the key points extracted by the 3D SIFT method and described with FPFH are used to simply represent the two pre-processed normalized PCD sets as K N P and K N Q , respectively. From a local perspective, these feature points have the ability of being scale-invariant and rotation-invariant.
  • Point pairs matching. The feature points extraction and description only take the local relationships of points into consideration. This step desires to incorporate global factors to determine the initial point pair matching. The graph is an ideal data structure for representing the global relationships of types of vertices. Among many graph structures [51,52], the bipartite graph structure is the most similar to the PCD structure, the simplest representation of the relationships between points and has the least computation amount. Moreover, inspired by the solution of the M-M assignment problem [53], we convert the point cloud feature matching process to handle the perfect matching based on the bipartite graph structure. The points in the source point cloud set K N P and the target point set K N Q denote the nodes of a bipartite graph structure G , as shown in Figure 3.
Figure 3. The bipartite graph structure representation of the K N P and K N Q .
Figure 3. The bipartite graph structure representation of the K N P and K N Q .
Electronics 11 00263 g003
In this phase, the KM algorithm is implemented with the point cloud bipartite graph structure G . The number of the point cloud set K N P and K N Q is recorded as n and m , respectively. In this bipartite graph structure G , a max ( m , n ) * max ( m , n ) adjacent matrix should be considered to represent edges of G , where the value of the i-th row and j-th column represent the similarity weight component s i m i l a r i t y ( F P F H ) i j j = 1 n s i m i l a r i t y ( F P F H ) i j of local feature descriptors. Here, the main objective is to find an assignment of point cloud set K N P and K N Q , with maximum total similarity weight. During the perfect matching process, the KM algorithm is used to find the maximum matching weight in the bipartite graph with the following steps: (1) select w i j as the maximum weight of edges, which is connected to k n p i and k n q j ; (2) choose a weighted match to find a subgraph with weight coverage; (3) set a coverage until a good match is obtained for the subgraph equation. The pseudo-code of the point pairs matching computation is shown in Algorithm 1.
Algorithm 1. Point Pairs Matching Algorithm
1input: pre-processed source point cloud K N P , pre-processed target point cloud K N Q ,
    FPFH descriptor for K N P and FPFH descriptor for K N Q
2output: initial point pairs set
3begin
4         N     K N P
5         V     K N Q
6    create max ( m , n ) * max ( m , n ) adjacent matrix and padding with zero
7    for each e i N and e j V  do
8        adjacent matrix value w i j similarity weight proportion of K N P and
         K N Q based on FPFH descriptor
9        append edge ( e i , e j )
10     end for
11     generate bipartite graph structure G = { N   V , E , W } for K N P and K N Q
12     initialize the matching subgraph as empty
13     for each e i N and e j V  do
14        find max w i j for labeling e i
15        find 0 for labeling e j
16      end for
17     while complete match of equal subgraphs exist
18        find an augmentation path
19        while augmentation path success
20            modify labeling value and find new find an augmentation path
21         end while
22        add the augmented path to the matching subgraph
23      end while
24     output matching as initial point pairs set
25end
  • Mismatch elimination. The optimal matching result of weighted bipartite graph responds to point correspondence matching solution between K N P and K N Q , but with some mismatching problems. In order to eliminate mismatched point pairs, two strategies about local descriptors’ similarity weight are mainly adopted and performed. At first, for each row i in the adjacent matrix, the corresponding maximum similarity location column j_max and the sum of similarity value of k n q 1 , , j _ m a x , n with k n p i will be recorded. Moreover, only the ratio similarity ( F P F H ) i j _ m a x to j = 1 n   similarity ( F P F H ) i j at location j is recorded, and all other columns are filled in 0. By this method, the point pair with the largest similarity is retained and other similarity point pair combinations are excluded, so the execution efficiency and accuracy of the algorithm are improved. Second, a lower threshold will be set for the maximum similarity component ration, which is denoted as t h r e s h o l d l o w . When the optimum perfect maximum point pair is obtained, the w i j of each point pair set needs to be compared with the t h r e s h o l d l o w value. If the w i j value is lower than t h r e s h o l d l o w , the correspondent point pair ( k n p i , k n q j ) should be abandoned to maintain the point pairs accuracy.
  • Rotation estimation. The acquisition of a corresponding point pair set is the most critical step in rough registration process, which aims to calculate the rotation matrix between the point pair sets. For K N P and K N Q , the rotation relationship is described in Equation (9). The singular value decomposition (SVD) algorithm is one of the most reliable orthogonal matrix decomposition methods, where U and Z represent two mutually orthogonal matrices and A represents an angular matrix. Referenced in [54], the SVD method is applied to solve the rotation matrix R, as shown (11).
    H = 1 n i = 1 n ( k n p i p ¯ ) ( k n q i q ¯ ) T ,
    where p ¯ = 1 n i = 1 n k n p i represents the center of mass K N P , and q ¯ = 1 n i = 1 n k n q i denotes the center mass of K N Q .
    The SVD of matrix H can be denoted as H = U D Z T , where D is d i a g ( d i ) and d 1 d 2 d 3 0 . When det ( U ) det ( V )   0 , the A should equal to I 3 , otherwise A is d i a g ( 1 , 1 , 1 ) . If r a n k ( H 2 ) , the rotation matrix R can be obtained by repeating U A Z T computation for several iterations. Moreover, the iterative process should end when the result of two adjacent iterations | f ( R k ) | n is less than pre-set threshold, where k is the iteration number.

3.4. The Fine Registration

The transformation relationship between two PCD contains translation matrix T, rotation matrix R and scale factor S. As the initial rotation matrix R has been estimated from coarse registration method and the S can be obtained from TT strategy, the further fine registration is conducted with TrICP to update R and compute T .
We list the pseudo-code of the proposed coarse-to-fine registration method in Algorithm 2.
Algorithm 2. The Coarse-to-Fine Registration Algorithm
1input: source point cloud P , target point cloud Q , SVD iteration number
    i t e r _ n u m S V D , and TrICP overlap ratio r a t i o T r I C P
2output: final transformation matrix
3begin
4    pre-process P and Q to obtain P and Q
5    normalize P and Q to obtain N P and N Q
6    extract feature points from N P as K N P and obtain FPFH descriptor
    extract feature points from N Q as K N Q and obtain FPFH descriptor
7    create bipartite graph structure for K N P   and   K N Q  
8    explore perfect maximum match between K N P and K N Q as initial
    correspondence points set
9    eliminate the mismatching point pairs
10    calculate K N P center mass as p ¯ and K N Q center mass as q ¯
11    compute matrix H as 1 n i = 1 n ( k n p i p ¯ ) ( k n q i q ¯ ) T
12    for iteration i = 1 : i t e r _ n u m S V D   do
13   if  r a n k ( H ) 2  then
14    while  | f ( R k ) | n > t h r e s h o l d p r e _ s e t  
15     update R = U A Z T
16   else
17    abort
18   end if
19     end for
20    rotate K N P with initial rotation matrix R to obtain K N P R point set
    rotate P with initial rotation matrix R to obtain P R point set
21    estimate scale factor S with | | K N Q m a x K N Q m i n | | | | K N P R m a x K N P R m i n | |
    adjust P R as S P R with S
22    search the nearest point from Q in S P R and calculate the distance squared D 2
23    sort D 2 from smallest to largest and calculate the sum of the first r a t i o T r I C P * Q
24    compute and output final rotation matrix R and translation matrix T
25end

4. Implementation and Performance Evaluation

In this section, we implement the proposed coarse-to-fine registration algorithm successfully with C++ language and point cloud library (PCL), which runs in ThinkPad X1 with Intel i7-10710 CPU and 16G memory. To comprehensively validate the performance of proposed algorithm, three groups of representative point cloud models have been selected, such as bunny rabbit, dragon from Stanford 3D model public library and room from PCL library. As shown in Figure 4, self-sampling raw 3D data, collected from two identical depth cameras in the same environment with a 45-degree difference, has also been considered to evaluate this algorithm. All testing PCD need pre-processing to eliminate noise interference with the hierarchical filter method proposed in this paper. Table 2 comprehensively summarizes the details of the test data sets.
The first group consists of bun045 and bun090 as testing objects with low overlap (poor initial position). Even in some experimental parts, bun090 is scaled to form a testing data set with a higher difficulty coefficient. Dragon000 and scaled dragon048 form the second data set to simulate testing objects with missing data and scaling factors. The third data set, containing room000 and room040, is used to validate registration performance without obvious features. The real scanning data of face000 and face045 constitute the fourth data set, used to measure the practicality of the alignment methods.
The performance validation experiment was conducted in three rounds. In the first phase, we mainly compared the registration accuracy of ICP and TrICP with or without the coarse alignment method and TT strategy proposed in this paper. In second stage, four representative coarse-to-fine registration algorithms were selected and compared with our proposed method in alignment accuracy and time consumption. For the last round, we combined the proposed TT strategy with the coarse alignment process in the above four selected algorithms and compared the performance of four combined registration methods with our proposed method in multiple scaling factors.
For the whole experiment, to reduce the computation time, we processed all testing PCD with voxel filter down sampling method VoxelGrid from PCL open-source library. The VoxelGrid divides the point cloud into voxel size value cubes and regards the center of gravity in each voxel as a point, which can greatly reduce the number of original PCD. The voxel size can directly affect the efficiency of the down sampling result, and only an appropriate voxel size value can better preserve the local morphological features. After testing, we find that the down sampling effect is optimal when the voxel size is set to 0.002: the number of bun045 is reduced to 6813, the number of bun090 is reduced to 6041, the number of dragon000 is reduced to 7155, the number of dragon048 is reduced to 4529, the number of room000 is reduced to 5387, the number of room040 is reduced to 7590, the number of face000 is reduced to 8508, the number of face045 is reduced to 8667, and all the down sampling data sets do not affect the subsequent processing. When the voxel size is set as less than 0.002, the retained number of points is larger. On the contrary, when A is set as larger than 0.002, the local morphological structure of some testing data sets (such as room and scanned face) could be damaged, and the feature point extraction results are much affected. Considering the above factors, the voxel size value is uniformly set to 0.002.
Time consumption and root mean square error (RMSE) are two important criterions for the registration algorithm performance evaluation. The time consumption is the indicator to measure the algorithm efficiency, and the RMSE, as described in (12), is used to quantify the registration accuracy.
R M S E = 1 m t i = 1 m t | | R p i + T q j | |
where m t denotes the matching points number and ( p i ,   q j ) is the matching point pair. The range of alignment accuracy obtained by the same registration algorithm in different PCD sets is not uniform, while different registration algorithms have the same range of alignment accuracy on the same PCD set. Since it is impossible to label a specific accuracy value for a particular alignment algorithm, we identify a registration algorithm with a higher accuracy by comparing the alignment RMSE of different algorithms on the same PCD set in the subsequent experiment.

4.1. The Availability Evaluation of Proposed Coarse Registration Method with TT Strategy

In the experiment, bun045-bun090, dragon000-dragon048 magnified 2 times and face000-face045 are selected to be the testing data set, as shown in Figure 5. We conduct tests on two ICP algorithms (ICP and TrICP) with different parameter-setting conditions, and the registration results are shown in Figure 6. The iteration number parameter can reflect ICP performance, and fewer iterations indicate a lower time consumption for processing the same data. Therefore, we set the iteration number parameter as 5, 10, 15, 30 and compare the corresponding alignment results. For the TrICP, a higher overlap ratio means to search for more points with a larger computation effort. We set the TrICP ratio to 0.65, 0.75, 0.85, 0.95 and compare the corresponding registration results. In Figure 7, we exhibit the registration results of the ICP and TrICP with the proposed coarse registration process and TT strategy (regarded as coarse-to-ICP and coarse-to-TrICP) under the same parameter-setting conditions of Figure 6. The registration errors are analyzed in Table 3 and Figure 8 and Figure 9. In visual presentation, the source point cloud data is marked as red and the target point cloud set as blue. Bun045, dragon000 and face000 are labeled in red, while bun090, dragon048 magnified 2 times and face045 are colored in blue.
The registration visual results of ICP and TrICP are presented in Figure 6a,b, respectively. We can obviously find that both of the algorithms have a bad registration effect in the bunny rabbit and scaled dragon, which indicates that ICP and TrICP have a bad ability to process PCD sets with a poor initial position and scale variations. Figure 7 illustrates the registration results of coarse-to-ICP and coarse-to-TrICP for bunny rabbit, scaled dragon and scanned face, which shows that the two algorithms can perform well in all three data sets. By comparing these visual results, our coarse registration method with TT strategy conducts very well, which significantly enhances comprehensive availability of original ICP and TrICP.
RMSE values with different iterations of ICP and ratio setting conditions of TrICP are recorded in Table 3. For the bunny rabbit and face testing sets without scaling factors, the coarse alignment process combined with TT strategy should degenerate to the coarse alignment method. As shown in the table, ICP and TrICP have higher RMSE values than coarse-to-ICP and coarse-to-TrICP, with the same bunny rabbit, face and parameter setting conditions, which validates the availability of the proposed coarse alignment method. For the scaled dragon data set, coarse-to-ICP and coarse-to-TrICP obviously have much lower RMSE values, which further demonstrates the effectiveness of the coarse alignment method combined with TT strategy.
In Figure 8, we compare the registration RMSE of ICP and coarse-to-ICP under different iterations and plot the results in a line chart. The line chart can be interpreted as: the x-axis shows different iterations; the y-axis represents registration error; the blue diamond connected by the dotted line indicates the RMSE trend of ICP; and the orange circle connected by the solid line shows the RMSE trend of coarse-to-ICP. In contrast to ICP, the coarse-to-ICP achieves convergence more efficiently (decrease from about 30 iterations to about 10 iterations) for a scanned face with good quality. Moreover, coarse-to-ICP can effectively avoid registration failure for poor initial position and scale variations data sets and can achieve convergence at about 15 iterations. We can conclude that the proposed coarse alignment method combined with TT strategy improves the performance of ICP.
Figure 9 displays the RMSE comparison of TrICP and coarse-to-TrICP with different ratio setting conditions. In this line chart, the x-axis represents multiple ratios, the y-axis shows RMSE value, the blue diamond connected by the dotted line presents RMSE variations of TrICP, and the orange circle connected by the solid line indicates RMSE of coarse-to-TrICP. By comparing the two RMSE curves, it can be analyzed that the proposed coarse registration method with TT strategy not only effectively compensates for the defects of TrICP in dealing with poor initial position and scale variations problems, but also speeds up algorithm convergence at a lower ratio setting. According to the observation of experimental results, when the ratio is set to 0.85, coarse-to-TrICP shows good performance. Moreover, comparing the RMSE of coarse-to-ICP and coarse-to-TrICP, the latter can achieve a lower RMSE, which indicates a more comprehensive and stable registration ability. Therefore, the TrICP algorithm used in subsequent experiments is set with a 0.85 ratio.

4.2. The Performance Evaluation of Multiple Coarse-to-Fine Registration Methods

In this part of the experiment, we mainly compare the performance of the complete coarse-to-fine registration algorithm proposed in this paper (combined with TT strategy) with four coarse-to-fine registration algorithms, such as NDT + ICP [33] (as the representative of probability model + ICP), ISS-3DSC-RANSAC + ICP [39] (as the representative of feature points with descriptors + coarse process + ICP), SAC-IA + ICP [33] (as the representative of coarse process + ICP) and K4PCS + ICP [35] (as the representative of feature points + coarse process + ICP).
The face000-face045, room000-room040, bun045-bun090, dragon000-dragon048 magnified two times and bun045-bun090 magnified 0.5 times are selected as the validation objects for this round of experiments. The visual registration results of different algorithms are exhibited in Figure 10. In these figures, the original source datasets are shown in green, the original target dataset is shown in blue and the registered datasets are in red. The total registration time, coarse phase time, fine process time and RMSE of each algorithm are recorded and analyzed in Figure 11.
For Figure 10a,b, the visual alignment results of face and room data sets apparently show that all five coarse-to-fine registration algorithms can effectively process PCD with obscure or general features. However, in Figure 10c, the visual results indicate that the alignment effect of a bunny rabbit with four compared coarse-to-fine registration algorithms, especially the NDT + ICP algorithm, is worse than the method proposed in this paper. This proves that our proposed algorithm is more robust in processing low overlap PCD sets. Moreover, Figure 10d,e reveals that four common coarse-to-fine algorithms fail in scaling alignment, except for the proposed method.
The numerical records and analysis of five coarse-to-fine algorithms about alignment time and accuracy for different datasets are presented in Figure 11: the horizontal coordinates are grouped by dataset name, where each group covers five registration algorithms (four compared algorithms and our proposed algorithm); the main vertical coordinate indicates the time in milliseconds, where the total registration time in blue bars, the coarse registration time in orange bars and the fine registration time in gray bars follow this axis; the secondary vertical coordinate shows the RMSE, where the registration errors of the five algorithms in all data models, represented by yellow boxes connected by yellow solid lines, follow this axis. As shown in Figure 11, the average registration time of NDT + ICP, ISS-3DSC-RANSAC + ICP, SAC-IA + ICP, K4PCS + ICP and our method for all data sets is 96.1208 ms, 17.2456 ms, 168.6878 ms, 10.377 ms and 76.081 ms, respectively. Analyzing from the perspective of algorithm execution efficiency, we can conclude that K4PCS + ICP is the highest and SAC-IA + ICP is the lowest, and our algorithm performs generally. For the non-scale point cloud object face and room, all five algorithms have similar small registration error, which indicates that these methods have close accuracy for aligning PCD with small position deviations or few features. However, our algorithm has the smallest 0.0117964 RMSE of bunny rabbit with poor initial position, which shows the proposed method has superior performance in processing low overlap rate PCD sets. Moreover, for data sets with scale variations, the RMSE of the four coarse-to-fine alignment algorithms is much higher compared to our proposed algorithm, which implies that these four algorithms fail to register scaling data sets and our proposed methods have more generality.

4.3. The Extensibility Evaluation of Multiple Registration Methods with TT Strategy

In order to test the performance of the coarse process in different coarse-to-fine algorithms combined with the TT strategy proposed in this paper, we scale the bunny rabbit and dragon data sets with multi factors (0.5, 1.5, 2) to simulate isotropic scale cases and form testing data sets: dragon000-dragon048 magnified 0.5 times, dragon000-dragon048 magnified 1.5 times, dragon000-dragon048 magnified 2 times, bun045-bun090 magnified 0.5 times, bun045-bun090 magnified 1.5 times and bun000-bun090 magnified 2 times. The experiment is conducted with the same coarse-to-fine registration algorithms mentioned in Section 4.2. The four course methods of NDT, ISS-3DSC-RANSAC, SAC-IA and K4PCS combine with the TT strategy, respectively, to modify NDT + ICP as NDT + ICP-TT, ISS-3DSC-RANSAC + ICP as ISS-3DSC-RANSAC + ICP-TT, SAC-IA + ICP as SAC-IA + ICP-TT, and K4PCS + ICP as K4PCS + ICP-TT. Figure 12 and Figure 13 respectively record the visual registration results of dragon and bunny rabbit with different scaling variations. In Figure 14, we compare scale estimation value with the real scale factor. Moreover, the registration errors are recorded and analyzed in Table 4 and Figure 15.
In Figure 12 and Figure 13, the original source data are colored in green, the scaled target object is labeled in blue and registered scaled-adjusted target object is shown in red. From the visual registration results in these figures, we find that the NDT + ICP-TT is less stable (large deviations in bun045 and bun090 magnified by 0.5), the performance of ISS-3DCS-RANSAC + ICP-TT, SAC-IA + ICP-TT and K4PCS + ICP-TT are close to each other, and our method is better. Our proposed TT strategy can extend the four coarse-to-fine registration algorithms to scale scenes effectively.
Figure 14 records scale factor estimation value of dragon and bunny rabbit data sets with different scale factors. The x-axis represents the scale factor category, the y-axis represents the scale estimation value, the blue bar indicates the scale factor estimation value of the dragon data set, the orange bar indicates the scale factor estimation value of the bunny rabbit object, and the red triangle shows the real scale factor value. For scale factor 0.5, the estimation value for dragon and bunny rabbit is 0.520670 (+4.13% error) and 0.488558 (−2.23% error). For scale factor 1.5, the estimation value for dragon and bunny rabbit is 1.61036 (+7.36% error) and 1.46719 (−2.19% error). For scale factor 2, the estimation value of dragon and bunny rabbit is 2.08243 (+4.12% error) and 1.95423 (−2.29% error). The average error of our scale-estimation value for dragon and bunny rabbit is −2.24% and +5.2%.
The registration results for RMSE of different coarse-to-fine algorithms with TT strategy are recorded in Table 4. As shown in the table, our method obtains the smallest errors of six scaled data sets, which indicates that our method’s performance is more stable and consistent than the other four coarse-to-fine registration algorithms with TT strategy. In Figure 15, we exploit boxplots to illustrate the RMSE for all data in Table 3: the x-axis represents five scale-adjusted coarse-to-fine registration algorithms; the y-axis represents the RMSE of each registration method; the central solid mark shows the median; and the bottom and top edges of the box are the 25th and 75th percentiles, respectively. Analyzing Table 3 and Figure 15, we explore that, except for NDT + ICP-TT which has a large RMSE in registering bun045 and bun090 magnified by 0.5, NDT + ICP-TT, ISS-3DSC-RANSAC + ICP-TT, SAC-IA + ICP-TT and K4PCS + ICP-TT have relatively similar errors, but they higher than our method for other data sets. Moreover, the comparison in Figure 10c and Figure 11, Table 4 and Figure 15 reveals that (1) NDT + ICP obviously fails to match bun045 and bun090, while NDT + ICP-TT has good registration results in bun045-bun090 magnified by 1.5 times and bun045-bun090 magnified by 2; (2) the registration RMSE of ISS-3DSC-RANSAC + ICP, SAC-IA + ICP and K4PCS + ICP is smaller than that of ISS-3DSC-RANSAC + ICP-TT, SAC-IA + ICP-TT and K4PCS + ICP-TT for the same PCD set, which is unavoidably caused by the scaling estimation error.
From the analysis above, we can conclude that our proposed TT strategy can be easily combined with current coarse-to-fine registration algorithms to adjust the source and target data sets to the same scale coordinate system, which effectively extend the applicability of alignment methods to scaling scenes. With a comprehensive consideration of the experimental results of Section 4.2 and Section 4.3, the efficiency of the coarse-to-fine registration algorithm (including the TT strategy) proposed in this paper is not optimal, but the excellent stable accuracy indicates this method has good extensibility and applicability whether including scaling factors or not.

5. Conclusions and Future Work

In this paper, we have proposed a coarse-to-fine registration algorithm with local feature extraction, feature description and bipartite graph global matching to confirm the initial correspondence, as well as TrICP to refine the transformation relationship. A weight threshold rejection method has been adopted to eliminate the initial correspondence error for further TrICP processing. Moreover, the TT strategy is designed to extend this alignment method to scaling cases, such as 3D object acquisition with different devices, by combing rough registration flexibly. The experiment is conducted in three phases and the results show that: 1. Compared with ICP on different iterations and TrICP on different overlap ratio settings for multiple PCD testing sets, the proposed coarse registration method combined with the TT strategy can accelerate the registration convergence speed, improve the registration accuracy and compensate the availability in scaling scenes effectively; 2. Compared with NDT + ICP, ISS-3DCS-RANSAC + ICP, SAC-IA + ICP and K4PCS + ICP algorithms, the RMSE and time consumption indicate that the proposed coarse-to-fine registration method has good efficiency, obviously higher accuracy and is more extensive; 3. Through comparing the RMSE of multiple coarse alignment methods combined with the proposed TT strategy, the corresponding original coarse-to-fine registration algorithms can be effectively improved in stability, accuracy and availability range. Although it is difficult to be widely applied due to the usage conditions, the ICP algorithm has been able to be used in some 3D data processing scenes, such as facial recognition, general consumer use, etc., with initial position, overlap rate and missing data conditions meeting the requirements. The comparison registration algorithms and the proposed algorithm in this paper are all based on the improvement of ICP. Specifically, the proposed registration method has good performance in aligning PCD sets with lower overlap, missing points, obscure features and scaling factors, which provides a better guarantee for extending the 3D data processing scenarios that have been applied. Future work should also address working with non-uniform density, improving the accuracy of TT strategy both in uniform and non-uniform density and optimizing the whole registration efficiency.

Author Contributions

Conceptualization and methodology, M.Y.; investigation, M.Y. and X.L. (Xiru Li); writing—original draft preparation, M.Y.; writing—review and editing, M.Y.; visualization, L.C. and H.T.; supervision and project administration, X.L. (Xiaofeng Li); resources, L.C. All authors have read and agreed to the published version of the manuscript.

Funding

This work was supported by the National Natural Science Foundation of Anhui under Grant 1708085QF153.

Data Availability Statement

Data sharing is not applicable.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Cao, K.; Jain, A.K. Automated Latent Fingerprint Recognition. IEEE Trans. Pattern Anal. Mach. Intell. 2019, 41, 788–800. [Google Scholar] [CrossRef] [Green Version]
  2. Carfagni, M.; Furferi, R.; Governi, L.; Servi, M.; Uccheddu, F.; Volpe, Y. On the Performance of the Intel Sr300 Depth Camera: Metrological and Critical Characterization. IEEE Sens. J. 2017, 17, 4508–4519. [Google Scholar] [CrossRef] [Green Version]
  3. Abate, A.F.; De Maio, L.; Distasi, R.; Narducci, F. Remote 3d Face Reconstruction by Means of Autonomous Unmanned Aerial Vehicles. Pattern Recognit. Lett. 2021, 147, 48–54. [Google Scholar] [CrossRef]
  4. Kang, G.; Zhang, Q.; Wu, J.; Zhang, H. Pose Estimation of a Non-Cooperative Spacecraft without the Detection and Recognition of Point Cloud Features. Acta Astronaut. 2021, 179, 569–580. [Google Scholar] [CrossRef]
  5. Tsai, C.; Tsai, S. Simultaneous 3d Object Recognition and Pose Estimation Based on Rgb-D Images. IEEE Access 2018, 6, 28859–28869. [Google Scholar] [CrossRef]
  6. Cheng, L.; Tong, L.; Li, M.; Liu, Y. Semi-Automatic Registration of Airborne and Terrestrial Laser Scanning Data Using Building Corner Matching with Boundaries as Reliability Check. Remote Sens. 2013, 5, 6260–6283. [Google Scholar] [CrossRef] [Green Version]
  7. Yuan, M.; Li, X.; Xu, J.; Jia, C.; Li, X. 3d Foot Scanning Using Multiple Realsense Cameras. Multimed. Tools Appl. 2021, 80, 22773–22793. [Google Scholar] [CrossRef]
  8. Dongzhen, W.; Ying, C.; Jipeng, L. Remote Sensing Image Registration Based on Dual-Channel Neural Network and Robust Point Set Registration Algorithm. In Proceedings of the 2020 5th International Conference on Intelligent Informatics and Biomedical Sciences (ICIIBMS), Naha, Japan, 18–20 November 2020; pp. 208–215. [Google Scholar]
  9. Wen, Y.; Mingquan, Z.; Guohua, G.; Xiaoning, L. A Hierarchical Skull Point Cloud Registration Method. IEEE Access 2019, 7, 132609–132618. [Google Scholar] [CrossRef]
  10. Huang, X.; Zhang, J.; Wu, Q.; Fan, L.; Yuan, C. A Coarse-to-Fine Algorithm for Matching and Registration in 3d Cross-Source Point Clouds. IEEE Trans. Circuits Syst. Video Technol. 2018, 28, 2965–2977. [Google Scholar] [CrossRef] [Green Version]
  11. Yu, Y.; Da, F.; Guo, Y. Sparse Icp with Resampling and Denoising for 3d Face Verification. IEEE Trans. Inf. Forensics Secur. 2019, 14, 1917–1927. [Google Scholar] [CrossRef]
  12. 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]
  13. Chen, Y.; Medioni, G. Object Modelling by Registration of Multiple Range Images. Image Vis. Comput. 1992, 10, 145–155. [Google Scholar] [CrossRef]
  14. Chetverikov, D.; Stepanov, D.; Krsek, P. Robust Euclidean Alignment of 3d Point Sets: The Trimmed Iterative Closest Point Algorithm. Image Vis. Comput. 2005, 23, 299–309. [Google Scholar] [CrossRef]
  15. Segal, A.; Haehnel, D.; Thrun, S. Generalized-Icp. In Proceedings of the Robotics: Science and Systems, Washington, DC, USA, 28 June–1 July 2009; p. 435. [Google Scholar]
  16. Yang, J.; Li, H.; Jia, Y. Go-Icp: Solving 3d Registration Efficiently and Globally Optimally. In Proceedings of the 2013 IEEE International Conference on Computer Vision, Sydney, Australia, 1–8 December 2013; pp. 1457–1464. [Google Scholar]
  17. Vlaminck, M.; Luong, H.; Philips, W. Multi-Resolution Icp for the Efficient Registration of Point Clouds Based on Octrees. In Proceedings of the 2017 Fifteenth IAPR International Conference on Machine Vision Applications (MVA), Nagoya, Japan, 8–12 May 2017; pp. 334–337. [Google Scholar]
  18. Liu, H.; Liu, T.; Li, Y.; Xi, M.; Li, T.; Wang, Y. Point Cloud Registration Based on Mcmc-Sa Icp Algorithm. IEEE Access 2019, 7, 73637–73648. [Google Scholar] [CrossRef]
  19. Biber, P.; Strasser, W. The Normal Distributions Transform: A New Approach to Laser Scan Matching. In Proceedings of the 2003 IEEE/RSJ International Conference on Intelligent Robots and Systems (IROS 2003) (Cat. No.03CH37453), Las Vegas, NV, USA, 27–31 October 2003; pp. 2743–2748. [Google Scholar]
  20. Myronenko, A.; Song, X. Point Set Registration: Coherent Point Drift. IEEE Trans. Pattern Anal. Mach. Intell. 2010, 32, 2262–2275. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  21. Zhou, J.; Ma, X.; Liang, L.; Yuhe, L.; Xu, S.; Ong, S.; Yang, Y. Robust Variational Bayesian Point Set Registration. In Proceedings of the 2019 IEEE/CVF International Conference on Computer Vision (ICCV), Seoul, Korea, 27 October–2 November 2019; pp. 9904–9913. [Google Scholar]
  22. Wang, Y.; Solomon, J. Deep Closest Point: Learning Representations for Point Cloud Registration. In Proceedings of the 2019 IEEE/CVF International Conference on Computer Vision (ICCV), Seoul, Korea, 27 October–2 November 2019; pp. 3522–3531. [Google Scholar]
  23. Yuan, W.; Eckart, B.; Kim, K.; Jampani, V.; Fox, D.; Kautz, J. Deepgmr: Learning Latent Gaussian Mixture Models for Registration. In European Conference on Computer Vision; Springer: Cham, Switzerland, 2020; pp. 733–750. [Google Scholar]
  24. Zeng, A.; Song, S.; Nießner, 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]
  25. Yew, Z.J.; Lee, G.H. Rpm-Net: Robust Point Matching Using Learned Features. In Proceedings of the 2020 IEEE/CVF Conference on Computer Vision and Pattern Recognition (CVPR), Seattle, WA, USA, 13–19 June 2020; pp. 11821–11830. [Google Scholar]
  26. Chen, C.-S.; Hung, Y.-P.; Cheng, J.-B. Ransac-Based Darces: A New Approach to Fast Automatic Registration of Partially Overlapping Range Images. IEEE Trans. Pattern Anal. Mach. Intell. 1999, 21, 1229–1234. [Google Scholar] [CrossRef] [Green Version]
  27. Aiger, D.; Mitra, N.J.; Cohen-Or, D. 4-Points Congruent Sets for Robust Pairwise Surface Registration. In Proceedings of the ACM Siggraph 2008 papers, Los Angeles, CA, USA, 11–15 August 2008; p. 85. [Google Scholar]
  28. Bellekens, B.; Spruyt, V.; Berkvens, R.; Weyn, M. A Survey of Rigid 3d Pointcloud Registration Algorithms. In Proceedings of the Ambient: The Fourth International Conference on Ambient Computing, Rome, Italy, 24–28 August 2014. [Google Scholar]
  29. 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; pp. 3212–3217. [Google Scholar]
  30. Theiler, P.W.; Wegner, J.D.; Schindler, K. Keypoint-Based 4-Points Congruent Sets–Automated Marker-Less Registration of Laser Scans. ISPRS J. Photogramm. Remote Sens. 2014, 96, 149–163. [Google Scholar] [CrossRef]
  31. Liu, Y.; Kong, D.; Zhao, D.; Gong, X.; Han, G. A Point Cloud Registration Algorithm Based on Feature Extraction and Matching. Math. Probl. Eng. 2018, 2018, 7352691. [Google Scholar] [CrossRef] [Green Version]
  32. 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]
  33. Shi, X.; Peng, J.; Li, J.; Yan, P.; Gong, H. The Iterative Closest Point Registration Algorithm Based on the Normal Distribution Transformation. Procedia Comput. Sci. 2019, 147, 181–190. [Google Scholar] [CrossRef]
  34. Wu, P.; Li, W.; Yan, M. Point Cloud Registration Algorithm Based on the Volume Constraint. J. Intell. Fuzzy Syst. 2020, 38, 197–206. [Google Scholar] [CrossRef]
  35. Lu, J.; Wang, W.; Shao, H.; Su, L. Point Cloud Registration Algorithm Fusing of Super 4pcs and Icp Based on the Key Points. In Proceedings of the 2019 Chinese Control Conference (CCC), Guangzhou, China, 27–30 July 2019; pp. 4439–4444. [Google Scholar]
  36. Wu, D.; Gao, J.; Xiao, Z.; Zhang, L.; Chen, X.; Tang, H.; Chen, Y.; He, Y. Triangular Model Registration Algorithm through Differential Topological Singularity Points by Helmholtz-Hodge Decomposition. IEEE Access 2019, 7, 34776–34790. [Google Scholar] [CrossRef]
  37. Yao, Z.; Zhao, Q.; Li, X.; Bi, Q. Point Cloud Registration Algorithm Based on Curvature Feature Similarity. Measurement 2021, 177, 109274. [Google Scholar] [CrossRef]
  38. Kamencay, P.; Sinko, M.; Hudec, R.; Benco, M.; Radil, R. Improved Feature Point Algorithm for 3d Point Cloud Registration. In Proceedings of the 2019 42nd International Conference on Telecommunications and Signal Processing (TSP), Budapest, Hungary, 1–3 July 2019; pp. 517–520. [Google Scholar]
  39. Xu, G.; Pang, Y.; Bai, Z.; Wang, Y.; Lu, Z. A Fast Point Clouds Registration Algorithm for Laser Scanners. Appl. Sci. 2021, 11, 3426. [Google Scholar] [CrossRef]
  40. Wang, X.; Li, Y.; Peng, Y.; Ying, S. A Coarse-to-Fine Generalized-Icp Algorithm with Trimmed Strategy. IEEE Access 2020, 8, 40692–40703. [Google Scholar] [CrossRef]
  41. Zha, H.; Ikuta, M.; Hasegawa, T. Registration of Range Images with Different Scanning Resolutions. In Proceedings of the 2000 IEEE International Conference on Systems, Man and Cybernetics, Nashville, TN, USA, 8–11 October 2000; Volume 1492, pp. 1495–1500. [Google Scholar]
  42. Du, S.; Zheng, N.; Ying, S.; Wei, J. Icp with Bounded Scale for Registration of M-D Point Sets. In Proceedings of the 2007 IEEE International Conference on Multimedia and Expo, Beijing, China, 2–5 July 2007; pp. 1291–1294. [Google Scholar]
  43. Ying, S.; Peng, J.; Du, S.; Qiao, H. A Scale Stretch Method Based on Icp for 3d Data Registration. IEEE Trans. Autom. Sci. Eng. 2009, 6, 559–565. [Google Scholar] [CrossRef]
  44. Du, S.; Cui, W.; Wu, L.; Zhang, S.; Zhang, X.; Xu, G.; Xu, M. Precise Iterative Closest Point Algorithm with Corner Point Constraint for Isotropic Scaling Registration. Multimed. Syst. 2019, 25, 119–126. [Google Scholar] [CrossRef]
  45. Yang, Y.; Fan, D.; Du, S.; Wang, M.; Chen, B.; Gao, Y. Point Set Registration with Similarity and Affine Transformations Based on Bidirectional Kmpe Loss. IEEE Trans. Cybern. 2021, 51, 1678–1689. [Google Scholar] [CrossRef]
  46. Huang, X.; Zhang, J.; Fan, L.; Wu, Q.; Yuan, C. A Systematic Approach for Cross-Source Point Cloud Registration by Preserving Macro and Micro Structures. IEEE Trans. Image Process. 2017, 26, 3261–3276. [Google Scholar] [CrossRef] [PubMed]
  47. Lowe, D.G. Distinctive Image Features from Scale-Invariant Keypoints. Int. J. Comput. Vis. 2004, 60, 91–110. [Google Scholar] [CrossRef]
  48. Shen, B.; Xu, X.; Qi, L.; Zhang, X.; Srivastava, G. Dynamic Server Placement in Edge Computing toward Internet of Vehicles. Comput. Commun. 2021, 178, 114–123. [Google Scholar] [CrossRef]
  49. Han, X.-F.; Jin, J.S.; Wang, M.-J.; Jiang, W.; Gao, L.; Xiao, L. A Review of Algorithms for Filtering the 3d Point Cloud. Signal Process. Image Commun. 2017, 57, 103–112. [Google Scholar] [CrossRef]
  50. Wang, S.; He, J.; Peng, S.; Gao, X. Research on Denoising Algorithm of 3d Point Cloud Data Based on Curvature Change. IOP Conf. Ser. Mater. Sci. Eng. 2020, 768, 072041. [Google Scholar] [CrossRef]
  51. Pathak, H.K.; Shahzad, N. Some Results on Best Proximity Points for Cyclic Mappings. Bull. Belg. Math. Soc. Simon Stevin 2013, 20, 559–572. [Google Scholar] [CrossRef]
  52. Alfuraidan, M.R.; Khamsi, M.A. Fixed Points of Monotone Nonexpansive Mappings on a Hyperbolic Metric Space with a Graph. Fixed Point Theory Appl. 2015, 2015, 44. [Google Scholar] [CrossRef]
  53. Zhu, H.; Liu, D.; Zhang, S.; Zhu, Y.; Teng, L.; Teng, S. Solving the Many to Many Assignment Problem by Improving the Kuhn–Munkres Algorithm with Backtracking. Theor. Comput. Sci. 2016, 618, 30–41. [Google Scholar] [CrossRef]
  54. 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, PAMI-9, 698–700. [Google Scholar] [CrossRef] [PubMed] [Green Version]
Figure 1. The relationship between a point pair P s and P t .
Figure 1. The relationship between a point pair P s and P t .
Electronics 11 00263 g001
Figure 2. Architecture of the coarse-to-fine registration.
Figure 2. Architecture of the coarse-to-fine registration.
Electronics 11 00263 g002
Figure 4. Real face point cloud data acquisition environment.
Figure 4. Real face point cloud data acquisition environment.
Electronics 11 00263 g004
Figure 5. Three groups of PCD consisting of bunny rabbit, dragon and scanned face. (a) Bunny rabbit bun045 and bun090. (b) Dragon000 and dragon048 with scale factor 2. (c) Scanned face face000 and face045.
Figure 5. Three groups of PCD consisting of bunny rabbit, dragon and scanned face. (a) Bunny rabbit bun045 and bun090. (b) Dragon000 and dragon048 with scale factor 2. (c) Scanned face face000 and face045.
Electronics 11 00263 g005
Figure 6. The registration results of two ICP algorithms with different parameter-setting conditions. (a) Three group data registration results of ICP with 5, 10, 15 and 30 iteration times. (b) Three group data registration results of TrICP with 0.65, 0.75, 0.85 and 0.95 overlap ratio.
Figure 6. The registration results of two ICP algorithms with different parameter-setting conditions. (a) Three group data registration results of ICP with 5, 10, 15 and 30 iteration times. (b) Three group data registration results of TrICP with 0.65, 0.75, 0.85 and 0.95 overlap ratio.
Electronics 11 00263 g006
Figure 7. The registration results of bunny rabbit, dragon and scanned face with coarse-to-ICP and coarse-to-TrICP. (a) Three group data registration results of coarse-to-ICP with 5, 10, 15 and 30 iteration times of ICP. (b) Three group data registration results of coarse-to-TrICP with 0.65, 0.75, 0.85 and 0.95 overlap ratio of TrICP.
Figure 7. The registration results of bunny rabbit, dragon and scanned face with coarse-to-ICP and coarse-to-TrICP. (a) Three group data registration results of coarse-to-ICP with 5, 10, 15 and 30 iteration times of ICP. (b) Three group data registration results of coarse-to-TrICP with 0.65, 0.75, 0.85 and 0.95 overlap ratio of TrICP.
Electronics 11 00263 g007
Figure 8. The RMSE records of ICP and coarse-to-ICP with different iterations. (a) RMSE values of ICP and coarse-to-ICP for bun045 and bun090 with 5, 10, 15, 30 iteration number. (b) RMSE values of ICP and coarse-to-ICP for dragon000 and magnified twice dragon048 with 5, 10, 15, 30 iteration number. (c) RMSE values of ICP and coarse-to-ICP for face000 and face045 with 5, 10, 15, 30 iteration number.
Figure 8. The RMSE records of ICP and coarse-to-ICP with different iterations. (a) RMSE values of ICP and coarse-to-ICP for bun045 and bun090 with 5, 10, 15, 30 iteration number. (b) RMSE values of ICP and coarse-to-ICP for dragon000 and magnified twice dragon048 with 5, 10, 15, 30 iteration number. (c) RMSE values of ICP and coarse-to-ICP for face000 and face045 with 5, 10, 15, 30 iteration number.
Electronics 11 00263 g008
Figure 9. The RMSE records of TrICP and coarse-to-TrICP with different ratios. (a) RMSE values of TrICP and coarse-to-TrICP for bun045 and bun090 with 0.65, 0.75, 0.85, 0.95 ratio settings. (b) RMSE values of TrICP and coarse-to-TrICP for dragon000 and magnified twice dragon048 with 0.65, 0.75, 0.85, 0.95 ratio settings. (c) RMSE values of TrICP and coarse-to-TrICP for face000 and face045 with 0.65, 0.75, 0.85, 0.95 ratio settings.
Figure 9. The RMSE records of TrICP and coarse-to-TrICP with different ratios. (a) RMSE values of TrICP and coarse-to-TrICP for bun045 and bun090 with 0.65, 0.75, 0.85, 0.95 ratio settings. (b) RMSE values of TrICP and coarse-to-TrICP for dragon000 and magnified twice dragon048 with 0.65, 0.75, 0.85, 0.95 ratio settings. (c) RMSE values of TrICP and coarse-to-TrICP for face000 and face045 with 0.65, 0.75, 0.85, 0.95 ratio settings.
Electronics 11 00263 g009
Figure 10. The visual registration results for testing data sets with five coarse-to-fine registration methods. (a) The original scanned face data and registration results of face000-face 045 with five coarse-to-fine registration methods. (b) The original room data and registration results of room000-room040 with five coarse-to-fine registration methods. (c) The original bunny rabbit data and registration results of bun045-bun090 with five coarse-to-fine registration methods. (d) The original scaled dragon data and registration result of dragon000-dragon048 magnified 2 times with five coarse-to-fine registration methods. (e) The original scaled bunny rabbit data and registration results of bun045-bun090 magnified 0.5 times with five coarse-to-fine registration methods.
Figure 10. The visual registration results for testing data sets with five coarse-to-fine registration methods. (a) The original scanned face data and registration results of face000-face 045 with five coarse-to-fine registration methods. (b) The original room data and registration results of room000-room040 with five coarse-to-fine registration methods. (c) The original bunny rabbit data and registration results of bun045-bun090 with five coarse-to-fine registration methods. (d) The original scaled dragon data and registration result of dragon000-dragon048 magnified 2 times with five coarse-to-fine registration methods. (e) The original scaled bunny rabbit data and registration results of bun045-bun090 magnified 0.5 times with five coarse-to-fine registration methods.
Electronics 11 00263 g010aElectronics 11 00263 g010bElectronics 11 00263 g010c
Figure 11. The registration performance records of testing data sets with five coarse-to-fine registration methods.
Figure 11. The registration performance records of testing data sets with five coarse-to-fine registration methods.
Electronics 11 00263 g011
Figure 12. The registration results for scaled dragon data set of multiple registration methods with TT strategy. (a) The dragon000 and dragon048 magnified by 0.5 and registration results of five coarse-to-fine registration methods combined with TT strategy. (b) The dragon000 and dragon048 magnified by 1.5 and registration results of five coarse-to-fine registration methods combined with TT strategy. (c) The dragon000 and dragon048 magnified by 2 and registration results of five coarse-to-fine registration methods with TT strategy.
Figure 12. The registration results for scaled dragon data set of multiple registration methods with TT strategy. (a) The dragon000 and dragon048 magnified by 0.5 and registration results of five coarse-to-fine registration methods combined with TT strategy. (b) The dragon000 and dragon048 magnified by 1.5 and registration results of five coarse-to-fine registration methods combined with TT strategy. (c) The dragon000 and dragon048 magnified by 2 and registration results of five coarse-to-fine registration methods with TT strategy.
Electronics 11 00263 g012aElectronics 11 00263 g012b
Figure 13. The registration results for scaled bunny rabbit data set of multiple registration methods with TT strategy. (a) The bun045 and bun090 magnified by 0.5 and registration results of five coarse-to-fine registration methods with TT strategy. (b) The original bun045 and bun090 magnified by 1.5 and registration results of five coarse-to-fine registration method with TT strategy. (c) The original bun045 and bun090 magnified by 2 and registration results of five coarse-to-fine registration method with TT strategy.
Figure 13. The registration results for scaled bunny rabbit data set of multiple registration methods with TT strategy. (a) The bun045 and bun090 magnified by 0.5 and registration results of five coarse-to-fine registration methods with TT strategy. (b) The original bun045 and bun090 magnified by 1.5 and registration results of five coarse-to-fine registration method with TT strategy. (c) The original bun045 and bun090 magnified by 2 and registration results of five coarse-to-fine registration method with TT strategy.
Electronics 11 00263 g013aElectronics 11 00263 g013b
Figure 14. The comparison of scale estimation value for different scale factors.
Figure 14. The comparison of scale estimation value for different scale factors.
Electronics 11 00263 g014
Figure 15. The RMSE boxplot of five coarse-to-fine registration algorithms combined with TT strategy in different scale factors. (a) The RMSE boxplot of different coarse-to-fine registration algorithms combined with TT strategy in scale = 0.5. (b) The RMSE boxplot of different coarse-to-fine registration algorithms combined with TT strategy in scale = 1.5. (c) The RMSE boxplot of different coarse-to-fine registration algorithms combined with TT strategy in scale = 2.
Figure 15. The RMSE boxplot of five coarse-to-fine registration algorithms combined with TT strategy in different scale factors. (a) The RMSE boxplot of different coarse-to-fine registration algorithms combined with TT strategy in scale = 0.5. (b) The RMSE boxplot of different coarse-to-fine registration algorithms combined with TT strategy in scale = 1.5. (c) The RMSE boxplot of different coarse-to-fine registration algorithms combined with TT strategy in scale = 2.
Electronics 11 00263 g015
Table 1. The comparison of different methods for extending rigid registration algorithms to isotropic scale cases.
Table 1. The comparison of different methods for extending rigid registration algorithms to isotropic scale cases.
MethodComputationPluggableExtensibility
Scale factor estimation from ESI [41]largenoenable
ICP with bounded scale [42]largenoenable
Scale-ICP proposed in [43]largenoenable
Scale-ICP proposed in [44]largenoenable
Scale estimation with GMM [10]largenoenable
Scale factor estimation [40]largenoenable
Scale factor computation [35]largenoenable
Scale normalization process [46]normalyesenable
TT strategy in this papersmallyesenable
Table 2. The details of test data sets.
Table 2. The details of test data sets.
NamePCD PresentationSizeDescription
bun045 Electronics 11 00263 i00140,097 pointsbunny rabbit with 45 degrees rotation and obvious features
bun090 Electronics 11 00263 i00230,379 pointsbunny rabbit with 90 degrees rotation and obvious features
dragon000 Electronics 11 00263 i00341,841 pointsoriginal dragon
dragon048 Electronics 11 00263 i00422,092 pointsdragon with 48 degrees rotation and missing points
room000 Electronics 11 00263 i005112,586 pointsoriginal room with indistinct features
room040 Electronics 11 00263 i006112,624 pointsroom with 40 degrees rotation and indistinct features
face000 Electronics 11 00263 i00762,695 pointsreal face scanned data with normal features
face045 Electronics 11 00263 i00858,882 pointsreal face scanned data with 45 degrees rotation and normal features
Table 3. The RMSE of ICP, coarse-to-ICP, TrICP and coarse-to-TrICP registration results.
Table 3. The RMSE of ICP, coarse-to-ICP, TrICP and coarse-to-TrICP registration results.
AlgorithmRabbitDragonFace
ICP5 iterations0.01526120.02186930.0200825
10 iterations0.0152280.02026730.0151241
15 iterations0.01521340.01994120.0137541
30 iterations0.0152110.01879530.0132282
coarse-to-ICP5 iterations0.01350640.0148080.0162803
10 iterations0.01342250.0133520.0133654
15 iterations0.01340950.01320340. 0132222
30 iterations0.01340960.0131810.0132146
TrICP0.65 ratio0.02619430.03222990.0349535
0.75 ratio0.02152440.03198840.0337509
0.85 ratio0.01602490.0209680.0305069
0.95 ratio0.01558480.0206630.0188006
coarse-to-TrICP0.65 ratio0.01262240.016760.0279336
0.75 ratio0.01244240.01628530.0202301
0.85 ratio0.01218010.01370990.0140438
0.95 ratio0.01188570.01329850.0133452
Table 4. The RMSE results of different coarse-to-fine registration algorithms with TT strategy under multiple scale factors.
Table 4. The RMSE results of different coarse-to-fine registration algorithms with TT strategy under multiple scale factors.
AlgorithmDragon (RMSE)Rabbit (RMSE)
NDT + ICP-TT0.5 scale0.003319750.00613571
1.5 scale0.01088560.0169368
2 scale0.0132790.0225726
ISS-3DCS-RANSAC + ICP-TT0.5 scale0.003320430.00564314
1.5 scale0.01095690.0169366
2 scale0.0133320.0225729
SAC-IA + ICP-TT0.5 scale0.003319570.0056327
1.5 scale0.01088350.0169363
2 scale0.0132510.0225733
K4PCS + ICP-TT0.5 scale0.003319740.00564319
1.5 scale0.01088550.0169364
2 scale0.0133120.0225728
Our method0.5 scale0.003130560.00554097
1.5 scale0.009466690.0162888
2 scale0.0131910.0202102
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Yuan, M.; Li, X.; Cheng, L.; Li, X.; Tan, H. A Coarse-to-Fine Registration Approach for Point Cloud Data with Bipartite Graph Structure. Electronics 2022, 11, 263. https://doi.org/10.3390/electronics11020263

AMA Style

Yuan M, Li X, Cheng L, Li X, Tan H. A Coarse-to-Fine Registration Approach for Point Cloud Data with Bipartite Graph Structure. Electronics. 2022; 11(2):263. https://doi.org/10.3390/electronics11020263

Chicago/Turabian Style

Yuan, Munan, Xiru Li, Longle Cheng, Xiaofeng Li, and Haibo Tan. 2022. "A Coarse-to-Fine Registration Approach for Point Cloud Data with Bipartite Graph Structure" Electronics 11, no. 2: 263. https://doi.org/10.3390/electronics11020263

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