Next Article in Journal
Visible Light Communication System Using an Organic Bulk Heterojunction Photodetector
Previous Article in Journal
MARS, a Multi-Agent System for Assessing Rowers’ Coordination via Motion-Based Stigmergy
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Analytic Performance Prediction of Track-to-Track Association with Biased Data in Multi-Sensor Multi-Target Tracking Scenarios

1
Department of Electronic Engineering, Tsinghua University, Beijing 100084, China
2
Unit 91715, Navy, People's Liberation Army, Guangzhou 510450, China
*
Author to whom correspondence should be addressed.
Sensors 2013, 13(9), 12244-12265; https://doi.org/10.3390/s130912244
Submission received: 23 July 2013 / Revised: 9 September 2013 / Accepted: 9 September 2013 / Published: 12 September 2013
(This article belongs to the Section Sensor Networks)

Abstract

: An analytic method for predicting the performance of track-to-track association (TTTA) with biased data in multi-sensor multi-target tracking scenarios is proposed in this paper. The proposed method extends the existing results of the bias-free situation by accounting for the impact of sensor biases. Since little insight of the intrinsic relationship between scenario parameters and the performance of TTTA can be obtained by numerical simulations, the proposed analytic approach is a potential substitute for the costly Monte Carlo simulation method. Analytic expressions are developed for the global nearest neighbor (GNN) association algorithm in terms of correct association probability. The translational biases of sensors are incorporated in the expressions, which provide good insight into how the TTTA performance is affected by sensor biases, as well as other scenario parameters, including the target spatial density, the extraneous track density and the average association uncertainty error. To show the validity of the analytic predictions, we compare them with the simulation results, and the analytic predictions agree reasonably well with the simulations in a large range of normally anticipated scenario parameters.

1. Introduction

In distributed multi-sensor surveillance systems, the process of associating sets of local estimates from multiple sensors is a fundamental problem, named track-to-track association (TTTA) [1,2]. It is valuable for predicting the performance of TTTA, not only in multi-sensor tracking system design, but also in subsequent situation assessment and on-line resource allocation, such as sensor tasking. Generally, performance evaluation mainly depends on Monte Carlo simulations, which are expensive and time-consuming. Furthermore, little insight can be obtained for the intrinsic relationship between the relevant scenario parameters and the performance based on numerical simulations. Therefore, analytic prediction of data association performance, which does not resort to detailed and costly simulations, is of significant practical and theoretical importance.

With respect to the analytic performance prediction of data association, Sea and Singer did pioneering work on the performance analysis of the nearest neighbor (NN) algorithm [3,4]. Saha provided a methodology for predicting the performance of a logic based ESM/radar TTTA algorithm [5]. Li et al. introduced the hybrid conditional averaging technique to predict the performance of the NN tracker [6]. Mei et al. gave the formula to calculate the theoretical probability of false association for TTTA using multiscan data [7]. Mori et al. derived an analytic expression, named the exponential law, to predict the performance of the global nearest neighbor (GNN) algorithm in terms of the probability of correct association [8,9]. On the basis of Mori's work [8], Ruan et al. developed an analytic performance prediction method for the feature-aided GNN algorithm [10]. Some oversimplified assumptions were employed in the derivations, including no false alarm, perfect detection, identical diagonal elements and all other identical elements in the feature confusion matrix, etc. Areta et al. presented procedures to calculate the probability that the measurement or the track originating from an extraneous target misassociated with a target of interest for the cases of NN and GNN association [11,12]. Mori et al. quantified the utility of additional feature/attribute information for TTTA in [13]. Although these works exhibit various degrees of success, they all do not take the impact of sensor biases on TTTA into consideration.

In performing multi-target tracking with a sensor network, the systematic errors, i.e., sensor biases, can hinder the fusion of data from multiple sensors. Specifically, TTTA is always problematic with biased data, while sensor bias registration usually requires correctly associated data. That is, association and registration actually affect each other [14,15]. To fix this problem, many approaches were proposed to formulate association and registration as a joint optimization problem. However, these joint problems are very difficult to solve, due to the combinatorial nature of the problem and the non-convexity of the objective function [1419]. Suboptimal solutions are obtained by performing association and registration in an alternately iterative manner. To a certain degree, the prediction of TTTA performance with biased data is also helpful for designing these joint association and registration algorithms.

A number of TTTA algorithms are built upon the GNN criterion [1,2,16,2023]. Most of them can be decomposed into two steps. The first step is to construct a matrix of association costs (or negative log-likelihood) between two sets of tracks. The second step usually consists of running a linear assignment algorithm on this cost matrix to determine the maximum likelihood association by globally minimizing the cost. The construction of the cost matrix was well discussed in [2224]. For the second step, many optimal linear assignment algorithms, such as Munkres [25], Jonker-Volgenant [26] and Jonker-Volgenant-Canstenon [27], can be adopted to identify the optimal associations. In this paper, we pay particular attention to predicting the performance of the GNN association algorithm with biased data analytically It should be noted that Castella [28] did consider the influence of biases on the performance of the multiple site track correlation technique proposed by Singer and Kanyuck [29], but the TTTA method of Singer and Kanyuck applies a gating technique and makes the association decision based on the NN rule, rather than the GNN criterion. The goal of our study is to extend the results in [8,9], which established an effective approach for predicting the performance of the optimal assignment algorithms, in an attempt to incorporate the impact of sensor biases.

The rest of the paper is structured as follows. Section 2 describes the single-scan TTTA problem. Section 3 presents the existing analytic prediction results of the bias-free situation. Section 4 provides the analytic prediction results for the GNN association algorithm with biased data. These results are verified via simulations in Section 5. Section 6 concludes the paper.

2. Problem Statement

In this paper, we consider a two-sensor single-scan TTTA problem. Although TTTA using multi-scan data has been theoretically proven to be better than that using single-scan data in [7], the former has higher computational complexity and may, in practice, exhibit lower power. That is because using multiscan data increases the degree of freedom of the test statistics, which has a negative impact on the power of the test [30,31]. Therefore, we focus on the single-scan TTTA problem, which is a data association problem with two random point sets in an m-dimensional Euclidean space, Sensors 13 12244i1m.

At a given time (without the time argument, for simplicity), the track set available at sensor A is denoted by ( y i , P A i ) i = 1 N A, where yi Sensors 13 12244i1m and P A i R m × m are the state estimate and error covariance matrix of the i-th target at sensor A, respectively; Na represents the number of tracks available at sensor A. Similarly to sensor A, the track set made by sensor B is ( z j , P B j ) j = 1 N B where zj Sensors 13 12244i1m and P B j R m × m are the state estimate and error covariance matrix of the j-th target at sensor B, respectively; Nb represents the number of tracks available at sensor B. Let y0 and z0 represent the dummy tracks of sensor A and B, respectively. When a track in a list is not associated with any track from the other list, it will be assigned to the dummy track. Following [8,32], we can define the association between the two track sets as a one-to-one mapping, a. Its domain is Dom(a) ⊆ = {1,…, NA}, and its range is Rng(a) ⊆ Sensors 13 12244i2 = {1, …, NB}. For iDom(a), a(i) is the index of the track from sensor B associated with track i from sensor A. Tracks in \ Dom(a) are associated with z0, while tracks in Sensors 13 12244i2 \ Range(a) are assigned to y0.

Let a* be the ground-truth association mapping. The track model is given as follows. We assume that sensors have translational biases on their local estimates of targets. The biases are modeled as additive constants. For a common target, i, we have:

y i = x i + b A + u i ,
z a * ( i ) = x i + b B + v i ,
where xi is the real state of target i, bA, bB represent the biases of sensor A and B, respectively, ui, vi are the random state estimation errors of target i at sensor A and B, respectively, and u i ~ N ( 0 , P A i ), v i ~ N ( 0 , P B i ).

The association can also be defined as an (NA + 1) ×(NB + 1) matrix h between ( y i ) i = 0 N A and ( z j ) j = 0 N B, with (i, j) element hij for i = 1, …, NA + 1, j = 1, …, NB + 1, such that

h ij = { 1 , if y i , z j are from the same target 0 , otherwise .

The relationship between a and h is: if a(i) = j, then hij = 1; if i \ Dom(a), then hi,0 = 1; if j Sensors 13 12244i2 \ Range(a), then h0,j = 1; otherwise hi,j = 0.

The GNN algorithm determines the best association decision from all possibilities by minimizing the overall cost [1,2]:

min h i = 0 N A j = 0 N B D i j h i j
subject to the constraints:
i = 0 N A h ij = 1 , j 0
j = 0 N B h ij = 1 , i 0
h ij { 0 , 1 } .

Constraints (5) and (6) guarantee that each track from a list is assigned to one and at most one track from the other list or to the dummy track. In problem (4), Dij (i, j ≠ 0) is the cost between yi and zj, defined by their normalized distance as:

D ij = z j y i S i , j 1 2 ,
where ‖xM denotes a semi-norm of a vector, x, defined by a nonnegative symmetric matrix, M, as x M = x T Mx; Si,j is the average association uncertainty covariance matrix and S i , j = P A i + P B j P AB i , j P AB i , j T; P A B i , j is the cross-covariance matrix, representing the correlation in the track errors, which results from the common process noise [33]. Because the correlation between tracks is difficult to obtain in practice, one can ignore it by assuming P A B i , j = 0 [23,24]. The effect of the cross-covariances on TTTA is beyond the scope of this paper, which can be found in [33,34]. We further assume that P A i = P A and P B j = P B for all i and j, such that S = PA + PB is strict positive definite.

In the GNN algorithm, the probability of correct association, PC, of target i is defined as:

P C = P { a ^ ( i ) = a * ( i ) } ,
where is the GNN optimal association estimate.

3. Previous Results with Bias-Free Data

Mori et al. [8,9] derived the analytic expression for the correct association probability, PC, of the GNN algorithm with bias-free data (i.e., bA = 0 in Equation (1), bB = 0 in Equation (2)), which obeys an exponential law:

P C = exp ( C m β T σ ¯ m ) ,
under the assumption of no false alarm and perfect detection. Considering the effects of extraneous objects, the expression of PC was changed into:
P C = exp [ ( C m β T + D m β F ) σ ¯ m ] .

The relevant parameters and assumptions used in Equations (10) and (11) (also effective in the subsequent analysis) are given as follows.

  • Cm is a constant defined by:

    C m = B m C ˜ m ,
    where:
    C ˜ m = 2 m 1 π 1 / 2 Γ ( m + 1 2 ) ,
    and Bm is the volume of the unit m-dimensional ball:
    B m = π m 2 Γ ( m 2 + 1 ) .

  • βT denotes the spatial density of targets defined as the expected number of targets in a unit volume of the measurement space, Sensors 13 12244i1m:

    β T = λ T B m r m .

    Targets are assumed to be independently identically distributed with a common distribution, which is uniform on a m-dimensional ball, with a large enough radius, r. The target number, NT, is a Poisson random variable with a mean, λT, that is:

    P ( N T ) = e λ T λ T N T N T ! .

  • Dm is a constant given by:

    D m = B m D ˜ m ,
    where:
    D ˜ m = 2 m / 2 Γ ( m ) Γ ( m / 2 ) .

  • βF denotes the spatial density of extraneous objects:

    β F = λ F B m r m .

    The states of the extraneous objects share the same distribution with targets. The number of false objects, NF, is another Poisson random variable with mean λF, that is:

    P ( N F ) = e λ F λ F N F N F ! .

  • σ̄ is the average innovation standard deviation.

Actually, the results of Equations (10) and (11) are specified for measurement-to-track association in single-sensor multi-target tracking problems. The novelty of this paper is to extend these results to the TTTA problem with biased data in multi-sensor multi-target tracking applications.

4. Analytic Performance Prediction of the GNN Algorithm with Biased Data

In this section, we consider the impact of sensor biases and propose the analytic prediction results for the GNN algorithm.

4.1. Association without Extraneous Tracks

First, we start with the two-target case, target i and j (ij). An optimal association, , is correct, i.e., (i) = a*(i) and a(j) = a*(j), if and only if the cost of the correct association is less than that of the incorrect association, that is:

D i , a * ( i ) + D j , a * ( j ) D i , a * ( j ) + D j , a * ( i ) ,
or, equivalently, if and only if:
Δ J ij = ˙ z a * ( i ) y i S i , a * ( i ) 1 2 + z a * ( j ) y j S j , a * ( j ) 1 2 z a * ( j ) y i S i , a * ( j ) 1 2 z a * ( i ) y j S j , a * ( i ) 1 2
= 2 ( z a * ( i ) z a * ( j ) ) S 1 ( y i y j ) 0.

Considering track model (1) and (2), we have:

z a * ( i ) z a * ( j ) = ( x i + b B + v i ) ( x j + b B + v j ) = ( x i x j ) + ( v i v j ) ,
y i y j = ( x i + b A + u i ) ( x j + b A + u j ) = ( x i x j ) + ( u i u j ) .

Then, Equation (23) is equivalent to:

( Δ u ij Δ v ij ) T S 1 Δ y ij Δ y ij S 1 2 ,
where:
Δ u ij = u i u j ,
Δ v ij = v i v j ,
Δ y ij = y i y j .

Thus, based on the detailed derivations in Appendix A, the probability of correct association with two targets is:

P C = P { a ^ ( i ) = a * ( i ) } = P { Δ J ij 0 } 1 C ˜ m ( σ ¯ r ) m ,
where σ̄ is the average association standard deviation, and:
σ ¯ = [ det ( S ) ] 1 2 m .

It is very difficult to extend Equation (30) to the multi-target case, because the incorrect associations may have more complicated errors besides the two-object transposition, such as the multi-object transposition. To overcome this difficulty, let the event, EC{(i) = a*(i)} (target i is correctly associated), be approximated by the event that there is no two-object transposition of ΔJij > 0 involving target i. With Equation (16) and a further assumption that the event {Δ Jij > 0} is independent for each j, i.e., each “potential” transposition is independent, we have:

P C = N T = 0 P { a ^ ( i ) = a * ( i ) | N T } | P ( N T )
= N T = 0 j = 1 , j i N T P { Δ J ij 0 } P ( N T )
= N T = 0 [ 1 C ˜ m ( σ ¯ r ) m ] N T 1 P ( N T )
= e λ T N T = 0 [ 1 C ˜ m ( σ ¯ r ) m ] N T λ T N T N T ! 1 C ˜ m ( σ ¯ r ) m
= C ˜ m exp ( C ˜ m β ˜ T )
= C ˜ m exp ( C m β T σ ¯ m ) ,
where:
C ˜ m = 1 1 C ˜ m ( σ ¯ r ) m ;
and:
β ˜ T = B m β T σ ¯ m
is the normalized target density, which is defined as the expected number of targets in the one-sigma ellipsoidal volume derived from the average association uncertainty covariance matrix, S. The formula:
e x = i = 0 + x i i !
is used in the derivation of Equation (36). The idea of independent transpositions was first introduced in [35], which gave some justification of this assumption. Generally, all possible association mappings are considered to be independent with each other and totally random. In this sense, the independent transposition assumption is reasonable.

Generally, rσ̄. Hence:

C ˜ m 1 ,
which was used in the derivation of Equation (10) in [8]. Consequently, Equation (37) becomes
P C exp ( C m β T σ ¯ m ) .

To maintain consistency with [810], Equation (42) is used in the following discussions. Since the bias terms are canceled out in Equations (24) and (25), Equation (42) is the same as (10), which does not account for sensor biases. Then, we can see that without extraneous and missed tracks, the translational biases do not affect the performance of the GNN association algorithm.

4.2. Extraneous Tracks Only Existing in One Track Set

In Section 4.1, we assumed that the cardinalities of the two given random point sets are identical. In reality, false tracks may disturb the situation. In this section, we discuss the effects of false tracks on the TTTA performance with biased data, in which there are false tracks only in the track set of sensor B. The event, EC{(i) = a*(i)}, can be written as

E C { a ^ ( i ) = a * ( i ) } E C T E C F ,
where ECT is the event that there is no transposition between target i and any other target and ECf is the event that target track yi is not associated with any false tracks. Since the targets and false alarms are independent from each other, we have:
P C = ˙ P ( E C { a ^ ( i ) = a * ( i ) } ) P ( E C T ) P ( E C F ) .

We can use the result of Equation (42) for P(ECT). The focus now is to analyze P(ECF) in the situation where sensors have translational biases.

Given an extraneous track, ze, and the target track, za*(i), from sensor B, let Pie be the probability that ze is not associated with yi, that is:

P ie = P { z a * ( i ) y i S 1 2 z e y i S 1 2 } .

Without loss of generality, let yi = 0. Then, Equation (45) is equivalent with:

P ie = P { z a * ( i ) S 1 2 z e S 1 2 } .

According to the track model (1), we can get the real state of target i, for the form only, as:

x i = b A u i .

Consequently, together with Equations (2) and (47), we have:

z a * ( i ) = b A u i + b B + v i = Δ b + v i u i ,
where:
Δ b = b B b A ,
is the relative translational bias vector between the two sensors. Then, based on Equations (1), (2) and (48), we have za*(i) ˜ Sensors 13 12244i3b, S). Thus, z a * ( i ) S 1 2 is distributed according to the noncentral chi-squared distribution with the degree of freedom, m, and the noncentrality parameter, δ, i.e., z a * ( i ) S 1 2 ~ χ m 2 ( δ ) [36]. The noncentrality parameter, δ, is:
δ = Δ b T S 1 Δ b .

Assuming that the extraneous track, ze, is uniformly distributed on the m-dimensional ball with radius r, the distribution of z e S 1 2 can be expressed as:

P { z e S 1 2 < y } = ( y r σ ¯ ) m .

Let Y = z e S 1 2; then, its probability density function is

f Y ( y ) = P ( Y < y ) y = m / 2 ( r σ ¯ ) m y m / 2 1 .

Let X = z a * ( i ) S 1 2 and the probability density function of X be denoted by fX (x; m, δ). Considering that the extraneous track, ze, and the target track, za*(i), are independent, the joint probability density function of random variables, X and Y, can be calculated as:

f X , Y ( x , y ) = f X ( x ) f Y ( y ) = f X ( x ; m , δ ) f Y ( y ) .

Then, we have:

P ie = P { X Y }
= { ( x , y ) : x y } f X , Y ( x , y ) dxdy
= + x + f X ( x ) f Y ( y ) dydx
= + x ( r σ ¯ ) 2 f X ( x ; m , δ ) m / 2 ( r σ ¯ ) m y m / 2 1 dydx
= m / 2 ( r σ ¯ ) m + f X ( x ; m , δ ) x ( r σ ¯ ) 2 y m / 2 1 dydx
= m / 2 ( r σ ¯ ) m + f X ( x ; m , δ ) ( ( r σ ¯ ) m x m / 2 ) m / 2 dx
= 1 ( r σ ¯ ) m [ + f X ( x ; m , δ ) ( r σ ¯ ) m dx + x m / 2 f X ( x ; m , δ ) dx ]
= 1 1 ( r σ ¯ ) m + x m / 2 f X ( x ; m , δ ) dx
= 1 1 ( r σ ¯ ) m ε χ m 2 ( δ ) ( x m / 2 )
= 1 D ˜ m ( σ ¯ r ) m ,
where:
D ˜ m ' = ε χ m 2 ( δ ) ( x m / 2 ) = + x m / 2 f X ( x ; m , δ ) d x .

If m = 2k and k is a positive integer, Equation (63) becomes

D ˜ m ' = ε χ m 2 ( δ ) ( x k ) ,
which is the kth order moment of the noncentral chi square distribution with degree of freedom m and noncentral parameter δ. If m = 2k + 1 and k is a nonnegative integer, Equation (63) is the fractional moment of the noncentral chi square distribution, and the calculation method of Equation (63) can be found in [37].

When there are NF false tracks in the track set of sensor B, with the independence assumption, the probability that no extraneous track is associated with yi is

P ( E C F | N F ) = P ie N F .

Under the assumption of the false track number in Equation (20), we have:

P ( E C F ) = e λ F N F = 0 λ F N F N F ! P ie N F
= exp [ λ F ( 1 P ie ) ]
= exp [ λ F D ˜ m ' ( σ ¯ r ) m ]
= exp [ β ˜ F D ˜ m ' ]
= exp [ B m β F σ ¯ m D ˜ m ' ]
= exp [ D m ' β F σ ¯ m ] ,
where
β ˜ F = B m β F σ ¯ m
is the normalized density of false tracks, and
D m ' = B m D ˜ m ' .

By substituting Equations (42) and (71) into Equation (44), we have:

P C = exp ( C m β T σ ¯ m ) exp [ D m ' β F σ ¯ m ]
= exp { [ C ˜ m β ˜ T + D ˜ m ' β ˜ F ] }
= exp { [ C m β T + D m ' β F ] σ ¯ m } .

When there are no extraneous tracks, i.e., βF = 0, Equation (76) is the same with Equation (42). The effect of sensor biases is coupled with false tracks by the multiplying factor, D m ' ( or D ˜ m ' ). With m = 2, we have Cm = π, D m ' = π ( 2 + δ ); then:

P C = exp { π [ β T + β F ( 2 + δ ) ] σ ¯ 2 } .

In addition, if sensors do not have biases (or have the same translational biases), i.e., Δb = 0, then δ = 0, D m ' = 2 π, and

P C = exp { π [ β T + 2 β F ] σ ¯ 2 } ,
which is consistent with Equation (11) under the two-dimensional case.

4.3. Extraneous Tracks Existing in Both Track Sets

When false tracks exist in both track sets, with a simple generalization of Equation (43), we have:

E C { a ^ ( i ) = a * ( i ) } E C T E C F A E C F B ,
where ECFA is the event that track yi is not associated with any false track from sensor B and ECFB is the event that track zj is not associated with any false track from sensor A. With the assumption that these events are independent, Equation (44) then is extended to:
P C P ( E C T ) P ( E C FA ) P ( E C FB )
= exp { [ C ˜ m β ˜ T + D ˜ m ' ( β ˜ FA + β ˜ FB ) ] }
= exp { [ C m β T + D m ' ( β FA + β FB ) ] σ ¯ m } ,
where βFA and βFB are the densities of false tracks made by sensor A and B, respectively; β ˜ FA and β ˜ FB are the normalized densities of false tracks made by sensor A and B, respectively.

Comparing Equation (82) with (76), it seems that the situation with false tracks in both track sets has the same difficulty with that in only one sensor. However, this is not true. As shown in Section 5.3, the relative quantities of false tracks between sensors have a large impact on the PC; so, the simple sum of βFA+ βFB in Equation (82) is not sufficient to reflect the intrinsic impact of false tracks on the correct association probability. Other risks in analytic performance prediction using Equation (82) will be examined through simulations in Section 5.3. Here, we just give the main conclusion that in a large range of normally anticipated operating conditions, Equation (82) can be used as an upper bound for the performance of the GNN association algorithm in terms of the correct association probability.

5. Simulation

To show the validity of our theoretical analysis, we test the above analytic results by comparing them to the simulation results. We consider the single-scan TTTA problem and make use of the Munkres algorithm to solve the GNN assignment problem [25]. The scenario consists of two sensors tracking multiple targets. The targets are distributed uniformly in a two-dimensional ball space (m = 2) with target extent radius r. The number of targets is a Poisson variable with mean λT = 20, and the target spatial density is varied by changing r. The random error covariance matrices of the target state estimates are presumed to satisfy PA = PB. The correlation among tracks from different sensors due to the common process noise is neglected in the following simulations, and the detailed analysis and simulations for the correlated tracks can be found in [33,34]. Sensors may report extraneous tracks, which are assumed to have the same spatial distribution with the target state. The track detection probability of each sensor is presumed to be one. Since the translational biases are in Cartesian coordinates, only the difference of them is observable. Therefore, the relative biases between sensors, instead of the absolute biases of each sensor, are considered in simulation. Let Δbx, Δby represent the relative translational biases in the x,y coordinate, respectively. All of the simulation results are based upon 500 Monte Carlo runs.

5.1. No Extraneous Tracks

When we study the validity of Equation (42) with biased data and no extraneous tracks, two simulation experiments are designed. The target spatial density, βT, is set to be 0.01, 0.025, 0.05 reports/km2, with the target extent radius r being 25.23, 15.95, 11.28 km, respectively. In the first experiment, the average association uncertainty covariance matrix is fixed to be S = diag[1, 1] km2, while Δbx, Δby vary from −3 km to 3 km in increments of 1 km. Tables 1, 2 and 3 show that the correct association probability, PC, obtained by simulations remains approximately unchanged and matches the analytic prediction well, even if the sensor biases vary in a big range. That is because, when no extraneous tracks exist, the PC of the GNN association algorithm is not associated with translational biases in Equation (42). From the comparison between Tables 1, 2 and 3, the theoretical PC value given by Equation (42) is less accurate as the track density increases. An explanation of this phenomenon is that, although the assumption of a large enough r is necessary in the derivation of Equation (42), the target extent radius, r, is not large enough under a high target density. Another possible reason might originate from the more complicated association errors, i.e., multi-object transpositions, which we did not model. However, the statistics concerning such “high-order” transpositions are not clear at the moment. In the second experiment, sensor biases are fixed to be Δbx = Δby = 1 km, while the average association variance, σ̄2, varies from 0 km2 to 2 km2 in increments of 0.4 km2. Figure 1 plots the correct association probability, PC, as a function of σ̄2, and each point is compared with the prediction (solid line) by Equation (42). The analytic prediction results match the simulation results very well, with a few exceptions: when the targets are dense and the average association variance is large. In view of the approximations we have employed, including some quite “bold” ones, such as the independent transposition assumption, this consistency between the simulation results and the theoretical prediction is rather remarkable.

5.2. Extraneous Tracks Only in One Track Set

When we test Equation (76) with extraneous tracks in the track set of sensor B, the normalized target density, β˜T, is fixed to be 0.05 reports, with the average association uncertainty covariance matrix, S = diag[0.5, 0.5] km2, and the target extent radius, r = 14.14 km. The relative translational biases are set as Δbx = Δby = 0, 1, 2 km. The ratio, β˜F/β˜T, is changed from zero to one in increments of 0.2. In each Monte Carlo run, false tracks are added according to given densities. Figure 2 shows the correct association probability as a function of the ratio, β˜F/β˜F, which determines the relative density of extraneous tracks to target tracks. The analytic prediction results (solid lines) match the simulation results (points) very well, and they perform better matching when small sensor biases occur.

5.3. Extraneous Tracks in Both Track Sets

When we test Equation (82) with extraneous tracks in both track sets, the average association covariance matrix is set to be S = diag[0.5, 0.5] km2, and Δbx is assumed to be equal with Δby varying from -3 km to 3 km in increments of 1 km. Let β˜F be the total normalized density of extraneous tracks, and β˜F = β˜FA + β˜FB. Let α be the ratio of false tracks from sensor A, and α = β˜FA/β˜F. Given the total density of false tracks, the parameter, α, reflects the allocation (or the relative quantity) of the extraneous tracks between sensor A and B. Four cases of α (α = 0, 0.1, 0.3, 0.5) are considered in the simulations. To better understand the prediction performance of Equation (82), two groups of simulation experiments are performed. In the first group, the normalized target spatial density, β˜T, is fixed to be 0.01 reports (accordingly, r is set as 31.62 km). Figures 3 and 4 plot the correct association probability as a function of sensor biases, with β˜F = 0.1β˜T and β˜F = β˜T, respectively. In the second group, β˜T is fixed to be 0.05 reports (accordingly, r is 14.14 km). Figures 5 and 6 plot the correct association probability as a function of sensor biases, with β˜F = 0.1β˜T and β˜F = β˜T, respectively.

Since a series of assumptions are made in the derivation of Equation (82), the prediction accuracy degrades in the scenario where false tracks exist in both sensors. When the number of extraneous objects is far less than the number of targets (β˜F = 0.1β˜T), the prediction results are an upper bound for the simulation results, and the prediction deviation is below 7%, as shown in Figures 3 and 5. While there are a lot of false tracks (β˜F = β˜T) in Figures 4 and 6, Figure 4 shows that, in the sparse-target scenario (β˜T = 0.01 reports), even with lots of false tracks, Equation (82) can also be used as an upper bound for the simulation results. Comparing Figure 6 with Figures 3, 4 and 5, we can see that this prediction upper bound becomes invalid only in the scenario with a high target density (β˜T = 0.05 reports), a high false track density (β˜F = β˜T) and large sensor biases (| Δbx| > 1.3km). Meanwhile, the prediction departure becomes larger as α increases. The fundamental reason for the prediction departure is not clear at this point. Two possible explanations are given as follows. First, in this complicated scenario, especially with a large α (≤ 0.5), false tracks of different sensors may associate with each other. This leads to a “reduction” of the false track density. In this sense, βFA + βFB in Equation (82) overestimates the density of false tracks. In addition, this false track “reduction” effect can be amplified under large sensor biases, since the multiplying factor, D m , in Equation (82) is a quadratic function of sensor biases. Second, when both track sets have false tracks, the multi-object transpositions we did not model are apt to occur. Yet, for all that, under large sensor biases and a large α (in Figure 6), the extreme pessimistic tendency of the prediction does not matter very much, because it appears only when PC is quite small (below 50%).

To sum up, in a large range of normally anticipated operating conditions, Equation (82) can be used as an upper bound for the simulation results. Further investigations are needed to provide a more accurate prediction of TTTA in the cases where false tracks exist in both sensors.

6. Conclusion

In this paper, we proposed an analytic performance prediction method for the GNN association algorithm with biased data in multi-sensor multi-target tracking applications. The probability of correct association is adopted as the performance criteria. The novelty of the method lies in that it accounts for the sensor biases in the TTTA problem, and analytic approaches are developed to reveal the intrinsic relationship between a set of key scenario parameters and the performance of the optimal TTTA algorithm. To verify the validity of the predictions, we compared them with the results of Monte-Carlo simulations. These shows that the analytic predictions agree reasonably well with the simulation results. In a word, the main results of the paper are as follows:

(1)

When both track sets are free from extraneous tracks, the correct association probability of the GNN association algorithm in Equation (42) has nothing to do with the translational biases of sensors. It is only related with target spatial density and the average association errors.

(2)

When one track set suffers from extraneous tracks, an exponential law was given in Equation (76), which uncovers the relationship between the correct association probability and the scenario parameters, including the average association errors, sensor biases, the target spatial density, as well as the false track density. The impact of sensor biases is embodied by an amplification coefficient of the false track density.

(3)

When both track sets contain extraneous tracks, an analytic upper bound of the correct association probability for the GNN association algorithm was proposed in Equation (82), which is effective in a large range of scenario parameters.

A series of assumptions were made to get concise and explicit mathematical results, including no missed detection, the translational bias model, identical association uncertainty covariance on all tracks, etc. The results derived based on these assumptions are not intended to be used directly in practice. The major contribution of the paper is to help designers understand the intrinsic relationship between a set of key scenario parameters and the performance of TTTA and to demonstrate the possibility that analytic performance prediction can be a potential substitute for the costly Monte Carlo simulation method.

To make the proposed analytic method more practical, a lot of work is needed in the following directions:

(1)

Further investigations are needed to improve the prediction accuracy of our method in the scenario where false tracks exist in both sensors. The statistics concerning the more complicated association error,s such as multi-object transpositions, can be addressed in the future.

(2)

For simplicity, we assumed that the track detection probabilities of both sensors are one. However, missed detections and false tracks do happen in real environments. To complicate matters, when missed detections occur at one sensor, the corresponding tracks that are supposed to associate with these missed tracks in the track set of the other sensor are equivalent to extraneous tracks for the remaining tracks of the former sensor. When sensors suffer from both missed detections and extraneous tracks, accounting for the missed detections in the formula of the correct association probability needs to be investigated in the future.

(3)

We only examined the impact of translational biases on the performance of TTTA. Since the impact of translational biases on the tracks is uncoupled with the states of targets, the translational biases can be named state-independent biases. However, in some applications, sensors can have biases on their range and azimuth measurements. The impact of these biases on the position estimates of targets is dependent on the real states of targets. Therefore, we name the range and azimuth biases the state-dependent biases. Under the scenario with state-dependent biases, the bias terms cannot be canceled out in Equations (24) and (25). Thus, the state-dependent biases affect the performance of the GNN association algorithm, even if there are no false tracks and missed detections. How to deal with the more complicated state-dependent biases in analytic performance prediction is left for the future.

Acknowledgments

The authors would like to thank the anonymous reviewers for their careful review and detailed comments, which have greatly improved the readability and contents of this paper.

In this appendix, we give the derivation of Equation (30). Most of the results in this appendix are taken from [8].

P C = P { a ^ ( i ) = a * ( i ) } = P { Δ J ij 0 }
= ε [ P ( ( Δ u ij Δ v ij ) T S 1 Δ y ij Δ y ij S 1 2 ) | Δ y ij ]
= ε ( erf ( α ij ) )
where α ij = Δ y ij s 1 / 2, ε[·] is the mathematical expectation operator, erf(·) is the error function defined as erf ( c ) 1 2 π c e t 2 / 2 dt and its complement is denoted by erfc(c), i.e., erfc(c) = 1 − erf(c).

Consider the case where target i is located at the origin, while target j is at a random position according to the uniform distribution within the m-ball with radius r. Then, we have:

ε ( erf ( α ij ) | y i = 0 ) = 1 ( B m r m ) 1 Δ y ij r erfc ( α ij ) d Δ y ij
= 1 ( B m r m ) 1 2 m / 2 [ det ( S ) ] 1 / 2 D ( r ) erfc ( η ) d η
1 B m 1 2 m / 2 ( σ ¯ r ) m R m erfc ( η ) d η ,
where D ( r ) { η R m | 2 η T S η r }; the approximation was made by replacing Sensors 13 12244i4(r) with Sensors 13 12244i1m, assuming that r is large enough. By using a kind of spherical integral shown in Appendix B, we have:
R m erfc ( η ) d η = m B m 0 ρ m 1 erfc ρ d ρ
= B m 1 2 π 0 ρ m e ρ 2 / 2 d ρ
= B m π 1 / 2 2 m 2 1 Γ ( m + 1 2 ) .

Then, based on Equations (88) and (91), we have:

ε ( erf ( α ij ) | y i = 0 ) = 1 C ˜ m ( σ ¯ r ) m ,
where m was given in Equation (13). Furthermore, since r is large enough, we can replace the condition, yi = 0, by “when the target is well inside the m-ball.” Therefore, we have:
P c = P { a ^ ( i ) = a * ( i ) } = P { Δ J ij 0 } 1 C ˜ m ( σ ¯ r ) m .

In this appendix, a kind of spherical integral, used in the derivation of Equation (30), is given by [38]. Let m be a positive integer and f be a real valued measurable function defined on [0, ∞), such that f(a) ≥ 0 for all a. Then, we have:

x < r f ( x ) d x = m B m 0 r ρ m 1 f ( ρ ) d ρ ,
for 0 ≤ r ≤ +∞, where ‖x‖ is the Euclidean norm on Sensors 13 12244i1m, and Bm is the volume of the unit ball in Sensors 13 12244i1m.

Conflicts of Interest

The authors declare no conflicts of interest.

References

  1. Blackman, S.S.; Popoli, R. Design and Analysis of Modern Tracking Systems; Artech House: Norwood, MA, USA, 1999. [Google Scholar]
  2. Bar-Shalom, Y.; Willett, P.K.; Tian, X. Tracking and Data Fusion; YBS publishing: Storrs, CT, USA, 2011. [Google Scholar]
  3. Sea, R.G. An Efficient Suboptimal DecisionProcedure for Associating Sensor Data with Stored Tracks in Real-Time Surveillance Systems. Proceeding of 1971 IEEE Conference on Decision and Control, Miami Beach, FL, USA, December 1971; pp. 33–37.
  4. Singer, R.; Sea, R.G. New results in optimizing surveillance system tracking and data correlation performance in dense multitarget environments. IEEE Trans. Autom. Control 1973, 18, 571–582. [Google Scholar]
  5. Saha, R.K. Analytical Evaluationof an Esm/Radar Track Association Algorithm. Proceeding of Signal and Data Processing of Small Targets, Orlando, FL, USA, April 1992; pp. 338–347.
  6. Li, X.R.; Bar-Shalom, Y. Tracking in clutter with nearest neighbor filters: Analysis and performance. IEEE Trans. Aerosp. Electron. Sys. 1996, 32, 995–1010. [Google Scholar]
  7. Mei, W.; Shan, G. Performance of a multiscan track-to-track association technique. Signal Process. 2005, 85, 1493–1500. [Google Scholar]
  8. Mori, S.; Chang, K.C.; Chong, C.Y. Performance analysis of optimal data association with applications to multiple target tracking. Multitarg. Multisens. Track. Appl. Adv. 1992, 2, 183–235. [Google Scholar]
  9. Mori, S.; Chang, K. C.; Chong, C.Y.; Dunn, K.P. Prediction of track purity and track accuracy in dense target environments. IEEE Trans. Autom. Control 1995, 40, 953–959. [Google Scholar]
  10. Ruan, Y.; Hong, L.; Wicker, D. Analytic performance prediction of feature-aided global nearest neighbour algorithm in dense target scenarios. IET Radar Sonar Navig. 2007, 1, 369–376. [Google Scholar]
  11. Areta, J.A.; Bar-Shalom, Y.; Rothrock, R. Misassociation probability in M2TA and T2TA. J. Adv. Inf. Fusion 2007, 2, 113–127. [Google Scholar]
  12. Areta, J.A.; Bar-Shalom, Y.; Rothrock, R. The Probability of Misassociation Between Neighboring Targets. Proceedings of Signal and Data Processing of Small Targets, Orlando, FL, USA, 16 March 2008; pp. 69691B:1–69691B:11.
  13. Mori, S.; Chong, C.Y.; Chang, K.C. Performance Prediction of Feature Aided Track-to-Track Association. Proceedings of the 14th International Conference on Information Fusion (FUSION 2011), Chicago, IL, USA, 5–8 July 2011; pp. 1–8.
  14. Chen, S.; Leung, H.; Bosse, E. A Maximum Likelihood Approach to Joint Registration, Association and Fusion for Multi-Sensor Multi-Target Tracking. Proceeding of 12th International Conference on Information Fusion (FUSION 2009), Seattle, WA, USA, 6–9 July 2009; pp. 686–693.
  15. Li, Z.; Chen, S.; Leung, H.; Bosse, E. Joint data association, registration, and fusion using em-kf. IEEE Trans. Aerosp. Electron. Sys. 2010, 46, 496–507. [Google Scholar]
  16. Moy, G.; Blaty, D.; Farber, M.; Nealy, C. Fusion of Radar and Satellite Target Measurements. Proceeding of Sensors and Systems for Space Applications IV, Orlando, FL, USA, 16 May 2011; pp. 804405–804405.
  17. Papageorgiou, D.J.; Sergi, J.D. Simultaneous Track-to-Track Association and Bias Removal Using Multistart Local Search. Proceeding of IEEE Aerospace Conference, Big Sky, MT, USA, 1–8 March 2008; pp. 1–14.
  18. Danford, S.; Kragel, B.; Poore, A. Joint Map Bias Estimation and Data Association: Algorithms. Proceeding of Signal and Data Processing of Small Targets, San Diego, CA, USA, 26 August 2007; pp. 66991E:1–66991E:18.
  19. Levedahl, M. Explicit Pattern Matching Assignment Algorithm. Proceedings of Signal and Data Processing of Small Targets, Orlando, FL, USA, 1 April 2002; pp. 461–469.
  20. Deb, S.; Yeddanapudi, M.; Pattipati, K.; Bar-Shalom, Y. A generalized sd assignment algorithm for multisensor-multitarget state estimation. IEEE Trans. Aeros. Electron. Sys. 1997, 33, 523–538. [Google Scholar]
  21. Pattipati, K.R.; Kirubarajan, T.; Popp, R.L. Survey of assignment techniques for multitarget tracking. Multitarg. Multisens. Track. Appl. Adv. 2000, 3, 77–159. [Google Scholar]
  22. Hurley, M.B. Track Association with Bayesian Probability Theory; Technical Report 1085; Massachusetts Institute of Technology Lincoln Laboratory: Cambridge, MA, USA; October; 2003. [Google Scholar]
  23. Kaplan, L.; Bar-Shalom, Y.; Blair, W. Assignment costs for multiple sensor track-to-track association. IEEE Trans. Aeros. Electron. Syst. 2008, 44, 655–677. [Google Scholar]
  24. Blair, W.D.; Kaplan, L.M. Assignment Costs for Multiple Sensor Track-to-Track Association. Proceeding of Seventh International Conference on Information Fusion (Fusion 2004), Stockholm, Sweden, 28 June–1 July 2004.
  25. Bourgeoism, F.; Lassalle, J.C. An extension of the munkres algorithm for the assignment problem to rectangular matrices. Commun. ACM 1971, 14, 802–804. [Google Scholar]
  26. Jonker, R.; Volgenant, A. A shortest augmenting path algorithm for dense and sparse linear assignment problems. Computing 1987, 38, 325–340. [Google Scholar]
  27. Castañón, D.A. New assignment algorithms for data association. Proceedings of Signal and Data Processing of Small Targets, Orlando, FL, USA, 20 April 1992; pp. 313–323.
  28. Castella, F.R. Theoretical Performance of a Multisensor Track-to-Track Correlation Technique. Proceeding of IEE Radar Sonar Navigation, December 1995; pp. 281–285.
  29. Singer, R.A.; Kanyuck, A.J. Computer control of multiple site track correlation. Automatica 1971, 7, 455–463. [Google Scholar]
  30. Tian, X.; Bar-Shalom, Y. Sliding Window Test vs. Single Time Test for Track-to-Track Association. Proceeding of 11th International Conference on Information Fusion (Fusion 2008), Cologne, Spain, 30 June–3 July 2008; pp. 1–8.
  31. Tian, X.; Bar-Shalom, Y. Track-to-track fusion configurations and association in a sliding window. J. Adv. Inf. Fusion 2009, 4, 146–164. [Google Scholar]
  32. Mori, S.; Chong, C.Y. Effects of Unpaired Objects and Sensor Biases on Track-to-Track Association: Problems and Solutions. Proceedings of MSS National Symposium on Sensor and Data Fusion, San Antonio, TX, USA, 20–22 June 2000; pp. 137–151.
  33. Bar-Shalom, Y.; Li, X.R. Multitarget-Multisensor Tracking: Principles and Techniques; University of Connecticut: Storrs, CT, USA, 1995. [Google Scholar]
  34. Bar-Shalom, Y.; Chen, H. Multisensor track-to-track association for tracks with dependent errors. J. Adv. Inf. Fusion 2006, 1, 2674–2679. [Google Scholar]
  35. Soule, P.W. Performance of Two-way Association of Complete Data Sets.; No. TOR0074(4085)-15; Aerospace Corp.: El Segundo, CA, USA; January; 1974. [Google Scholar]
  36. Kay, S.M. Fundamentals of Statistical Signal Processing, Volume 2: Detection Theory; Prentice Hall PTR: London, UK, 1998. [Google Scholar]
  37. Harvey, J.R. Fractional Moments of a Quadratic Form in Noncentral Normal Random Variables. PhD. Thesis, North Carolina State University, April 1965. [Google Scholar]
  38. Fortmann, T.E.; Bar-Shalom, Y.; Scheffe, M.; Gelfand, S. Detection Thresholds for Multi-Target Tracking in Clutter; No. 5495; BBN Laboratory. Inc.: Cambridge, MA, USA; December; 1983. [Google Scholar]
Figure 1. Correct association probability as a function of the average association uncertainty variance—analytic prediction results against simulation results. Target spatial density βT is 0.01, 0.025, 0.05 reports/km2. Sensor biases are set as Δbx = Δby = 1 km.
Figure 1. Correct association probability as a function of the average association uncertainty variance—analytic prediction results against simulation results. Target spatial density βT is 0.01, 0.025, 0.05 reports/km2. Sensor biases are set as Δbx = Δby = 1 km.
Sensors 13 12244f1 1024
Figure 2. Correct association probability as a function of β˜F/β˜T—analytic prediction results against simulation results. The normalized target spatial density, β˜T, is fixed to be 0.05 reports. Sensor biases are Δbx = Δby = 0,1,2 km.
Figure 2. Correct association probability as a function of β˜F/β˜T—analytic prediction results against simulation results. The normalized target spatial density, β˜T, is fixed to be 0.05 reports. Sensor biases are Δbx = Δby = 0,1,2 km.
Sensors 13 12244f2 1024
Figure 3. Correct association probability as a function of sensor biases when both track sets contain extraneous tracks—analytic prediction results versus simulation results. The normalized target spatial density, β˜T, is fixed to be 0.01 reports. The total normalized false track density is set as β˜F = 0.1β˜T.
Figure 3. Correct association probability as a function of sensor biases when both track sets contain extraneous tracks—analytic prediction results versus simulation results. The normalized target spatial density, β˜T, is fixed to be 0.01 reports. The total normalized false track density is set as β˜F = 0.1β˜T.
Sensors 13 12244f3 1024
Figure 4. Correct association probability as a function of sensor biases when both track sets contain extraneous tracks—theoretical prediction versus simulation results. The normalized target spatial density, β˜T, is fixed to be 0.01 reports. The total normalized false track density is set as β˜F = β˜T.
Figure 4. Correct association probability as a function of sensor biases when both track sets contain extraneous tracks—theoretical prediction versus simulation results. The normalized target spatial density, β˜T, is fixed to be 0.01 reports. The total normalized false track density is set as β˜F = β˜T.
Sensors 13 12244f4 1024
Figure 5. Correct association probability as a function of sensor biases when both track sets contain extraneous tracks—analytic prediction results versus simulation results. The normalized target spatial density, β˜T, is fixed to be 0.05 reports. The total normalized false track density is set as β˜F = 0.1β˜T.
Figure 5. Correct association probability as a function of sensor biases when both track sets contain extraneous tracks—analytic prediction results versus simulation results. The normalized target spatial density, β˜T, is fixed to be 0.05 reports. The total normalized false track density is set as β˜F = 0.1β˜T.
Sensors 13 12244f5 1024
Figure 6. Correct association probability as a function of sensor biases when both track sets contain extraneous tracks—analytic prediction results versus simulation results. The normalized target spatial density, β˜T, is fixed to be 0.05 reports. The total normalized false track density is set as β˜F = β˜T.
Figure 6. Correct association probability as a function of sensor biases when both track sets contain extraneous tracks—analytic prediction results versus simulation results. The normalized target spatial density, β˜T, is fixed to be 0.05 reports. The total normalized false track density is set as β˜F = β˜T.
Sensors 13 12244f6 1024
Table 1. The impact of sensor biases on correct association probability—the prediction by Equation (42) is 96.90%. βT = 0.01 reports/km2.
Table 1. The impact of sensor biases on correct association probability—the prediction by Equation (42) is 96.90%. βT = 0.01 reports/km2.
PC (%)Δbx
−3km−2km−1km0km1km2km3km
Δby-3 km96.8797.1696.6397.2397.4897.5597.09
-2 km96.8596.8697.0397.2397.2697.1097.06
-1 km97.2196.8096.3796.9196.6296.9597.00
0 km97.4397.3796.7997.2497.2697.4396.95
1 km97.1997.0497.6797.5297.1197.1697.17
2 km97.0797.2097.1796.9097.6297.6797.32
3 km97.2697.0897.2896.8897.1997.1797.11
Table 2. The impact of sensor biases on correct association probability—the prediction by Equation (42) is 92.44%. βT = 0.025 reports/km2.
Table 2. The impact of sensor biases on correct association probability—the prediction by Equation (42) is 92.44%. βT = 0.025 reports/km2.
PC (%)Δbx
−3km−2km−1km0km1km2km3km
Δby-3 km92.9893.1493.0793.3693.4792.9692.5
-2 km93.5492.9893.5593.0393.2593.1893.27
-1 km92.8794.0292.8393.1593.3592.9892.21
0 km93.0392.4193.3093.2193.0093.0292.89
1 km92.1493.6792.8792.9593.4493.4493.92
2 km93.1792.8092.4093.1193.2492.7693.15
3 km92.8792.9193.5892.8393.1493.1792.77
Table 3. The impact of sensor biases on the correct association probability—the prediction by Equation (42) is 85.46%. βT = 0.05 reports/km2.
Table 3. The impact of sensor biases on the correct association probability—the prediction by Equation (42) is 85.46%. βT = 0.05 reports/km2.
PC (%)Δbx
−3km−2km−1km0km1km2km3km
Δby-3 km87.8186.8587.2087.7986.7387.0386.62
-2 km87.5186.8386.4887.3486.3186.2987.63
-1 km86.8887.7886.6686.6386.6187.2886.25
0 km87.2487.0786.3988.1387.6486.4686.98
1 km87.1787.0187.1086.6387.0286.9588.18
2 km86.7386.6886.7487.2786.4287.1086.86
3 km86.4886.4987.2886.8586.5787.3486.71

Share and Cite

MDPI and ACS Style

Tian, W.; Wang, Y.; Shan, X.; Yang, J. Analytic Performance Prediction of Track-to-Track Association with Biased Data in Multi-Sensor Multi-Target Tracking Scenarios. Sensors 2013, 13, 12244-12265. https://doi.org/10.3390/s130912244

AMA Style

Tian W, Wang Y, Shan X, Yang J. Analytic Performance Prediction of Track-to-Track Association with Biased Data in Multi-Sensor Multi-Target Tracking Scenarios. Sensors. 2013; 13(9):12244-12265. https://doi.org/10.3390/s130912244

Chicago/Turabian Style

Tian, Wei, Yue Wang, Xiuming Shan, and Jian Yang. 2013. "Analytic Performance Prediction of Track-to-Track Association with Biased Data in Multi-Sensor Multi-Target Tracking Scenarios" Sensors 13, no. 9: 12244-12265. https://doi.org/10.3390/s130912244

Article Metrics

Back to TopTop