Next Article in Journal
MAC-Bridging for Multi-PHYs Communication in BAN
Previous Article in Journal
A Wireless Sensor Network Based Personnel Positioning Scheme in Coal Mines with Blind Areas
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

QMRPF-UKF Master-Slave Filtering for the Attitude Determination of Micro-Nano Satellites Using Gyro and Magnetometer

1
School of Instrumentation Science and Optoelectronics Engineering, Beijing University of Aeronautics and Astronautics, Beijing 100191, China
2
School of Instrumentation Science and Optoelectronics Engineering, Beijing University of Aeronautics and Astronautics, Beijing 100191, China
*
Author to whom correspondence should be addressed.
Sensors 2010, 10(11), 9935-9947; https://doi.org/10.3390/s101109935
Submission received: 17 September 2010 / Revised: 10 October 2010 / Accepted: 15 October 2010 / Published: 5 November 2010
(This article belongs to the Section Chemical Sensors)

Abstract

: In this paper, the problem of estimating the attitude of a micro-nano satellite, obtaining geomagnetic field measurements via a three-axis magnetometer and obtaining angle rate via gyro, is considered. For this application, a QMRPF-UKF master-slave filtering method is proposed, which uses the QMRPF and UKF algorithms to estimate the rotation quaternion and the gyro bias parameters, respectively. The computational complexicity related to the particle filtering technique is eliminated by introducing a multiresolution approach that permits a significant reduction in the number of particles. This renders QMRPF-UKF master-slave filter computationally efficient and enables its implementation with a remarkably small number of particles. Simulation results by using QMRPF-UKF are given, which demonstrate the validity of the QMRPF-UKF nonlinear filter.

Graphical Abstract

1. Introduction

Spacecraft attitude is important for attitude control in many space missions. In the last four decades, a great number of research works have been devoted to the problem of estimating spacecraft attitude based on a sequence of noisy vector observations, resolved in the body-fixed coordinate system and in a reference system [17].

For the attitude sensor, the sun sensor, Earth sensor, star tracker, three-axis magnetometer, and gyro etc, are often used. The attitude estimation problem possesses an undesirable strong nonlinearity. The filtering-based methods that were developed in the 1980s embedded the attitude determination problem in the framework of stochastic filtering. The mostly used filtering method is the extended Kalman filter (EKF) [2,8]. Nevertheless, poor performance or even divergence arising from the linearization implicit in the EKF has led to the development of other filters [3,9,10]. Another often used method is the unscented Kalman filter (UKF), also known as the sigma-point filter [4]. Unscented filters are essentially based on second or higher-order approximations of nonlinear functions, which are used to estimate the mean and covariance of the state vector. In [4], an unconstrained three-component vector is used, based on the generalized Rodrigues parameters to represent an attitude error quaternion. The state vector includes the attitude error and bias vectors. UKF, as a Kalman filter mechanization, is sensitive to the statistical distribution of the stochastic processes driving the dynamic model: non-Gaussian distributions guarantee nonoptimality of the estimates. Recently, a new method using the particle filtering (PF) technique has been proposed for a spacecraft’s attitude estimation [1,57]. Based on the concept of sequential importance sampling and the use of Bayesian theory, particle filtering is particularly useful in dealing with nonlinear and non-Gaussian problems. However, the most notorious disadvantage of a particle filter is its formidable computational complexity, since hundreds even thousands of particles are usually needed to achieve required approximation accuracy, and then it is difficult to achieve real time performance. A particle filtering algorithm [1] copes with the curse of computational complexity related to PFs by using an efficient initialization procedure, along with an importance weight cooling schedule and particle set portioning. This method is applicable to gyroless attitude determination setting, and the state vector is composed of a unit norm quaternion and a three-element angular-rate vector. In [5], particle filtering for attitude estimation using a minimal local-error representation (MLERPF) is proposed. The main character of MLERPF is that it does not work well when the number of particles is not large enough, which brings limitation to some applications.

This paper develops a QMRPF-UKF master-slave filter and gives its implementation in the case of a three-axis stabilized micro-nano satellite, obtaining noisy geomagnetic field measurements via a three-axis magnetometer and obtaining the noisy angle rate via gyro. In order to reduce the computational cost rising from the increased state dimensions, the quaternion multiresolution particle filter (QMRPF) algorithm is used as the master filter to estimate the attitude quaternion, and the unscented Kalman filter algorithm is used as the slave filter to determine the gyro bias parameters. On the other hand, the new estimator copes with the curse of computational complexity related to the particle filtering technique by introducing multiresolution approach that permits a significant reduction in the number of particles [11]. This renders the QMRPF-UKF master-slave filter computationally efficient and significant computational savings of QMRPF master filter is achieved by drastically reducing the needed number of particles. The performance of QMRPF-UKF in various scenarios is studied and compared with MLERPF method, which demonstrates the validity of QMRPF-UKF nonlinear filter.

This paper is organized as follows. In Section 2, the system model of the attitude determination of a three-axis stabilized micro-nano satellite by using gyro and magnetometer is given. In Section 3, the QMRPF-UKF master-slave filter is described in detail. In Section 4, the QMRPF-UKF master-slave filter for the attitude determination problem is verified on the basis of its estimation accuracy and computational time. We draw some conclusions in Section 5.

2. System Model

2.1. Quaternion Process Model

It is known that the body angular motion can be described in terms of the attitude quaternion by the following equation:

q k + 1 = Ω ( ω k ) q k
where ω k = [ ω x k ω y k ω z k ] T denotes the angular velocity vector of the rotation of B with respect to R. qk denotes the quaternion of rotation from a given reference frame R onto the body frame B at times k = 1,2, ..., ∞. The quaternion is constructed from vector part k and scalar part q4k:
q k = [ q ¯ k T q 4 k ] T

Assuming that ωk is constant during the sampling time interval Δt, the orthogonal transition matrix Ω(ωk) is expressed using ωk and computed as follows:

Ω ( ω k ) = [ cos ( 0.5 ω k Δ t ) I 3 × 3 [ ψ k × ] ψ k ψ k T cos ( 0.5 ω k Δ t ) ] 4 × 4
ψ k = sin ( 0.5 ω k Δ t ) ω k ω k
where [ψk ×] denotes the cross-product matrix associated with the vector ψk.

2.2. Rate Sensor Measurement Model

A common sensor that measures the angular rate is a rate-integrating gyro. For this sensor, a widely used model is given by:

ω ˜ k = ω k + β k + η v , k
β k + 1 = β k + η u , k
where ω̃k is the measured rate; βk is the gyro bias vector; ηv,k and ηu,k are independent zero-mean Gaussian white-noise processes with:
E { η v ( t ) η v T ( τ ) } = σ v 2 δ ( t τ ) I 3 × 3
E { η u ( t ) η u T ( τ ) } = σ u 2 δ ( t τ ) I 3 × 3
where E{·} denotes expectation and δ(tτ) is the Dirac_delta function.

2.3. Observation Model

A widely used attitude measurement model is given by:

b k = A ( q k ) r k + δ b k
where bk is the body-frame vector and rk is the reference-frame vector; δbk denotes the measurement noise process, with known probability density function (PDF) denoted as δbkpδbk; where A(qk) denotes the rotation matrix that brings the axes of R onto the axes of B at time k. The attitude matrix is related to the quaternion by:
A ( q k ) = [ ( q 4 k ) 2 q ¯ k T q ¯ k ] I 3 × 3 + 2 q ¯ k q ¯ k T 2 q 4 k [ q ¯ k × ]

3. QMRPF-UKF Master-Slave Filter

In this Section, the QMRPF-UKF master-slave filtering method is proposed, which uses the QMRPF and UKF algorithms to estimate the rotation quaternion and the gyro bias parameters, respectively. Section 3.1 formulates a detailed process of QMRPF master-filter. Section 3.2 describes the UKF slave-filter process. The flow chart of the QMRPF-UKF master-slave filter with multiresolution approach embedded at time k = M is shown in Figure 1, where ① denotes the master filter, and ② denotes the slave filter.

3.1. QMRPF Master-Filter

QMRPF master-filter is provided to estimate the quaternion from pairs of vector observations, and computational efficiency of quaternion particle filter (QPF) is achieved by using the spatial-domain multiresolutional approach. This section is divided into three parts: QMRPF master-filter mathematical model, the complete step sum-up of QMRPF master-filter, quaternion particle filter with multiresolution embedded.

A. QMRPF Master-Filter Mathematical Model

Taking attitude quaternion as state variable, the mathematical model of QMRPF master-filter is built. State equation is

q k = Ω ( ω ˜ k 1 β k 1 ) q k 1

Measurement equation is Equation (9). From Equation (11), it can be seen that, the gyro bias estimation at time k – 1 will be used for estimating the attitude quaternion at time k.

B. Complete Step Sum-up of QMRPF Master-filter

The time is supposed to be k = M when the multiresolution approach is embedded into the quaternion particle filter.

  • Initializing the quaternion particles { q 0 i } i = 1 N and setting quaternion weights as { w 0 i } = 1 / N , i = 1, ..., N.

  • For k < M, quaternion particle filter is used to estimate the attitude quaternion k at time k, and the quaternion particles { q k i } i = 1 N and { w k i } i = 1 N are also obtained.

  • For k = M, QMRPF algorithm is adopted to determinate the rotation quaternion k at time k, the number N of particles is reduced to be Ñ. { q _ k i } i = 1 N ˜ and { w _ k i } i = 1 N ˜ are derived at time M.

  • For k > M, the basic step is the same as step 2, but the number of quaternion particles is Ñ.

C. Quaternion Particle Filter with Multiresolution Embedded

In the following, we will show how k is estimated when the multiresolution approach is embedded into the quaternion particle filter at time k = M.

(1) Particle weights multiresolution decomposition

A partition of N samples into N/2L blocks is used where L is the level number of multiresolution decomposition, and then particle weights of every block are decomposed into lowpassed and highpassed components.

W m , l h , k 1 = [ w ˜ m , l 1 , k 1 1 w ˜ m , h 1 , k 1 1 w ˜ m , h L , k 1 1 w ˜ m , h L , k 1 2 L 1 ] = T [ w ˜ m , k 1 1 w ˜ m , k 1 2 L ] , m = 1 , , N / 2 L
where T denotes an orthogonal wavelet decomposition transform matrix; m denotes the m-th block; { w ˜ m , k 1 i } i = 1 2 L are the particle weights of the m-th block at time k – 1; w ˜ m , l 1 , k 1 1 is the lowpass-filtered particle weight; { w ˜ m , h j , k 1 i } i = 1 2 j 1 are the highpass-filtered particle weights at level j(j = 1, ..., L), and the number of weights at scale j is 2j−1.

(2) Thresholding the highpass-filtered particle weights

A simple thresholding is carried out on the highpass-filtered particle weights of every block:

w _ m , h j , k 1 i = { w ˜ m , h j , k 1 i , | w ˜ m , h j , k 1 i | > T s 0 , | w ˜ m , h j , k 1 i | T s ( j = 1 , , L ; i = 1 , , 2 j 1 )
where Ts is the wavelet threshold. Thus we have the thresholded weights:
W _ m , l h , k 1 = [ w ˜ m , l 1 , k 1 1 , w _ m , h 1 , k 1 1 , , w _ m , h L , k 1 1 , , w _ m , h L , k 1 2 L 1 ] T

(3) Quaternion particles selection

The thresholded weight Wm,lh,k−1 corresponds to quaternion particles { q _ m , l h , k 1 i } i = 1 2 L. Therefore, we can just propagate the elements in q _ m , k 1 i = T T q _ m , l h , k 1 i which corresponds to the distinct elements in Wm,k–1 = TTWm,lh,k–1. For the repeated elements of Wm,k–1, we can propagate one corresponding representative element in q _ m , k 1 i, The number of quaternion particles is selected to be Ñ by the thresholding operation, which can significantly reduce the computation in propagation while maintaining performance. Some detailed information about the multiresolution process can be referenced to [11].

Now let { q _ k 1 i } i = 1 N ˜ and { w _ k 1 i } i = 1 N ˜ denote Ñ independent quaternion particles and their associated weights, Ñ denotes the number of quaternion particles selected.

(4) Time update

The prediction values { q k | k 1 i } i = 1 N ˜ are obtained from Equation (11), where βk–1 is the estimation of the gyro bias at time k – 1 via UKF algorithm.

(5) Measurement update (the update of weight):

w k i p b k | q k ( b k | q k | k 1 i ) w _ k 1 i = p δ b k ( b k A ( q k | k 1 i ) r k ) w _ k 1 i , i = 1 , ... , N ˜
where p b k | q k ( b k | q k | k 1 i ) is the likelihood probability of the measurement bk associated to a given quaternion q k | k 1 i, pδbk is the probability density function of δbk. Particle weights w k i are normalized to w ˜ k i:
w ˜ k i = w k i i = 1 N ˜ w k i , ( i = 1 , ... , N ˜ )

(6) Quaternion estimation

At time k, Ñ weighted quaternion samples are available. To obtain the filtered quaternion via minimum mean square error (MMSE) approach, the following minimization problem is solved [6]:

min A ^ k i = 1 N ˜ w ˜ k i A k ( q k / k 1 i ) A ^ k F 2 ,   subject   to A ^ k T A ^ k = I 3 × 3
where Âk denotes the orthogonal attitude matrix associated with the filtered quaternion, and ||·||F is the Frobenius norm. The constrained minimization problem (17) is equivalent to the unconstrained maximization problem in quadratic form as follows:
max tr A ^ k [ A ^ k T i = 1 N ˜ w ˜ k i A k ( q k / k 1 i ) ] = max q ^ k q ^ k T K q ^ k
with:
K = [ B k + B k T I 3 × 3 t r ( B k ) z z T t r ( B k ) ] , z = [ B k ( 3 , 2 ) B k ( 2 , 3 ) B k ( 1 , 3 ) B k ( 3 , 1 ) B k ( 2 , 1 ) B k ( 1 , 2 ) ],

Letting:

B k = i = 1 N ˜ w ˜ k i A ( q ^ k | k 1 i )

As in Davenport’s well-known q-method, the quaternion that solves the maximization problem of Equation (18) is the normalized eigenvector corresponding to the largest eigenvalue of K:

K q ^ k = λ max q ^ k

Then the attitude quaternion estimation k at time k = M is obtained.

3.2. UKF Slave-Filter

The gyro output can’t be used for attitude estimation directly for the reason that the gyro has a bias vector, and thus the gyro bias is considered in the estimation process. The UKF slave-filter is designed to estimate the gyro bias vector. Taking gyro bias as state variable, the state space model of slave filter, UKF, is built on the basis of gyro bias model and vector observation model. State equation is Equation (6), and observation equation is:

b k = A ( Ω ( ω ˜ k 1 β k 1 ) q k 1 ) r k + δ b k

The noise variance matrix of state model and observation model are supposed to be Qσu2 and Rδb, respectively. Q σ u 2 = σ u 2 I 3 × 3.

It can be seen that, the state equation is linear and the observation equation is nonlinear. Moreover, the attitude quaternion at time k – 1 will be used to estimate the gyro bias at time k. The steps of gyro bias estimation using UKF is as follows:

  • Initialization

    β ^ 0 = E [ β 0 ] , P β 0 = E [ ( β 0 β ^ 0 ) ( β 0 β ^ 0 ) T ]
    where β0 and β̂0 are the real value and estimation value of gyro bias at the starting time, respectively. Pβ0 denotes the estimation error variance matrix at the starting time.

  • Calculating sigma points

    { χ k 1 ( 0 ) = β ^ k 1 χ k 1 ( i ) = β ^ k 1 + n + τ ( P β ^ k 1 ) i χ k 1 ( i + n ) = β ^ k 1 n + τ ( P β ^ k 1 ) i , i = 1 , , n
    where β̂k–1 and Pβ̂k–1 denote the estimation value and estimation error variance matrix at time k – 1, respectively; n denotes state dimension, and for this application, n = 3. Supposing that the estimation error variance matrix Pβ̂k–1 = AAT, ( P β ^ k 1 ) i denotes the i-th column of matrix A.

  • Calculating the weights of sigma points

    The weights corresponding to the sigma points are given by:

    { W ( 0 ) = τ / ( n + τ ) W ( i ) = 1 / [ 2 ( n + τ ) ] W ( n + i ) = 1 / [ 2 ( n + τ ) ] , i = 1 , , n

  • Time update

    The predicted mean and error variance matrix of the gyro bias at time k are given by:

    β ^ k ¯ = β ^ k 1 , P β ¯ ^ k = P β ^ k 1 + Q σ u 2

  • Measurement update

    b ^ k | k 1 ( i ) = A ( Ω ( ω ˜ k 1 χ k 1 ( i ) ) q ^ k 1 ) r k , i = 0 , 1 , ... , 2 n

    The prediction mean of the measurement vector at time k is calculated using a weighted sum of the points k|k–1(i), which is given by:

    b ^ k ¯ = i = 0 2 n W ( i ) b ^ k | k 1 ( i )

    The measurement variance and cross correlation between β̂ and are computed by:

    P b k b k = i = 0 2 n W ( i ) ( b ^ k | k 1 ( i ) b ^ k ¯ ) ( b ^ k | k 1 ( i ) b ^ k ¯ ) T + R δ b
    P β k b k = i = 0 2 n W ( i ) ( χ k 1 ( i ) β ^ k ¯ ) ( b ^ k | k 1 ( i ) b ^ k ¯ ) T
    The Kalman gain is:
    K k = P β k b k P b k b k 1
    Then the estimation value and estimation error variance matrix of gyro bias at time k are described by:
    β ^ k = β ^ k ¯ + K k ( b k b ^ k ¯ )
    P β ^ k = P β ¯ ^ k K k P b k b k K k T

4. Simulation Results and Analysis

In our simulation, the micro-nano satellite orbit is in sun synchronization orbit with 900 km altitude. Gyro and magnetometer are integrated for attitude determination. The magnetic field reference is modeled using a 10th-order International Geomagnetic Reference Field model. Magnetometer noise is modeled by a zero-mean Gaussian white-noise process with a standard deviation of 50 nT. The gyros’ output is contaminated with measurement noise having two components: white, zero-mean Gaussian process with intensity ( 0.31623 μ rad / s 1 2 ) 2 and gyro bias modeled as integrated Gaussian white noise with intensity ( 3.1623 × 10 4 μ rad / s 3 2 ) 2. The initial attitude error angle is 0°, the initial gyro bias is 0.2(°/h) on each axis, the gyro bias variance matrix is [0.2(°/h)]2 × I3×3, the measurement noise matrix of magnetometer is 502 I3×3 (nT)2, the sampling frequency is 10 Hz, simulation time is 3,000 s. The initial particle number of QMRPF-UKF method is 600. The threshold is 0.5 × 10−4. The starting time of performing multiresolutional transform is the 1,000 s. QMRPF-UKF master-slave filtering is used to perform the attitude determination of this micro-nano satellite. The codes are run on a computer, the processor speed of which is 2.5 GHz and memory is 2 Gbyte. In testing the filter, we look for two filter attributes: computational cost and accuracy.

The estimation error of gyro/magnetometer integrated attitude angle estimation is shown in Figure 2. In Figure 3, the gyro bias estimation error is given. It can be seen that the attitude angle estimation error is smaller than 0.1°, and the gyro bias estimation error is smaller than 0.01°/h.

Here, we run QMRPF-UKF algorithm in 50 runs of Monte Carlo simulation with different thresholds to validate the effectiveness and complexity of QMRPF-UKF for the attitude determination of a micro-nano satellite. The performance is measured via RMS (root mean square) estimation error of Monte Carlo simulation. The smaller the RMS estimation error resulting from the filter is, the better the filter performance is. Figure 4 gives the selected particles numbers after performing multiresolution particle filter with different thresholds. RMS error and the computational cost of QMRPF-UKF with different thresholds are given in Table 1. It can be seen that, the larger the threshold is, the smaller the number of surviving particles is. With the increase of threshold, the computational time is decreased, and the filtering varies in estimation precision.

QMRPF-UKF is compared with the existing method, MLERPF, in terms of RMS error and computational cost, as shown in Table 1. It can be seen that, QMRPF-UKF outperforms MLERPF significantly in terms of computational cost and QMRPF-UKF is comparable to MLERPF in terms of estimation precision. For MLERPF, the state dimension of performing particle filter is six, which is larger than that of QMRPF-UKF. Moreover, in the calculating process of MLERPF, the particle number is invariant. For QMRPF-UKF master-slave filter, the filtering performance is improved from two aspects. On the one hand, in order to reduce the computational cost rising from the augment of the state dimensions, QMRPF algorithm is used as the master filter to estimate the attitude quaternion, and UKF is used as the slave filter to determine the gyro bias parameters. On the other hand, QMRPF copes with the curse of computational complexity related to the particle filtering technique by introducing multiresolution approach that permits a significant reduction in the number of particles.

Three simulation scenarios are carried out to verify the convergence performance of QMRPF-UKF. The first one is that, the initial attitude error angle is 50°, 50°, and 50° for each axis, respectively. The second one is that, the initial attitude error angle is −70°, 40°, and 100° for each axis, respectively. The third one is that, the initial attitude error angle is −60°, 30°, and 130° for each axis, respectively. These are added into the initial condition of attitude estimation. For each simulation scenario, other parameters are same as the above mentioned ones. QMRPF-UKF convergences in each simulation. The attitude angle estimation error is smaller than 0.1°, and the gyro bias estimation error is smaller than 0.01°/h.

5. Conclusions

We have developed a computationally efficient QMRPF-UKF master-slave filtering method, to solve the problem of gyro/magnetometer integrated attitude determination of a three-axis stabilized micro-nano satellite. Computational efficiency of the proposed filtering is achieved by combining the master-filter with slave-filter and by adopting the spatial-domain multiresolutional approach to reduce the needed number of particles while maintaining comparable estimation accuracy. The larger the threshold is, the fewer the number of surviving particles, and the filtering varies in estimation precision.

Acknowledgments

The authors would like to thank the anonymous reviewers for their comments, which improved the presentation of this paper. This research has been supported by National Natural Science Foundation of China under grant 60704010, 61004140, the National Basic Research Program (973 Program) of China under grant 2009CB72400204, National High Technology Research and Development Program (863 Program) of China under Grant 2008AA12A216.

References and Notes

  1. Carmi, A; Oshman, Y. Fast particle filtering for attitude and angular-rate estimation from vector observations. J. Guid. Contr. Dynam 2009, 32, 70–78. [Google Scholar]
  2. Markley, FL. Attitude error representations for Kalman Filtering. J. Guid. Contr. Dynam 2003, 63, 311–317. [Google Scholar]
  3. Choukroun, D; Bar-Itzhack, IY; Oshman, Y. Novel quaternion Kalman Filter. IEEE Trans. Aerosp. Electron. Syst 2006, 42, 174–190. [Google Scholar]
  4. Crassidis, JL; Markley, FL. Unscented Filtering for spacecraft attitude estimation. J. Guid. Contr. Dynam 2003, 26, 536–542. [Google Scholar]
  5. Cheng, Y; Crassidis, JL. Particle filtering for attitude estimation using a minimal local-error representation. Proceedings of AIAA Guidance, Navigation, and Control Conference, Chicago, IL, USA, 2009. AIAA 2009-6309..
  6. Oshman, Y; Carmi, A. Attitude estimation from vector observations using a genetic algorithm-embedded quaternion particle filter. J. Guid. Contr. Dynam 2006, 29, 879–891. [Google Scholar]
  7. Carmi, A; Oshman, Y. Robust spacecraft angular rate estimation from vector observations using interlaced particle filtering. J. Guid. Contr. Dynam 2007, 30, 1729–1741. [Google Scholar]
  8. Crassidis, JL; Junkins, JL. Optimal Estimation of Dynamic Systems; Chapman & Hall/CRC: Boca Raton, FL, USA, 2004; Charts 2 and 5. [Google Scholar]
  9. Psiaki, ML. Backward-smoothing extended Kalman Filter. J. Guid. Contr. Dynam 2005, 28, 885–894. [Google Scholar]
  10. Haupt, GT; Kasdin, NJ; Keiser, GM; Parkinson, BW. Optimal recursive iterative algorithm for discrete nonlinear least-squares estimation. J. Guid. Contr. Dynam 1996, 19, 643–649. [Google Scholar]
  11. Hong, L; Wicker, D. A Spatial-domain multiresolutional particle filter with thresholded wavelets. Signal Process 2007, 87, 1384–1401. [Google Scholar]
Figure 1. QMRPF-UKF master-slave filter with multiresolution approach embedded at time k = M.
Figure 1. QMRPF-UKF master-slave filter with multiresolution approach embedded at time k = M.
Sensors 10 09935f1 1024
Figure 2. Estimation error of attitude angle.
Figure 2. Estimation error of attitude angle.
Sensors 10 09935f2 1024
Figure 3. Estimation error of gyro bias.
Figure 3. Estimation error of gyro bias.
Sensors 10 09935f3 1024
Figure 4. Selected particle number after performing QMRPF-UKF with different thresholds.
Figure 4. Selected particle number after performing QMRPF-UKF with different thresholds.
Sensors 10 09935f4 1024
Table 1. Comparison of QMRPF-UKF with MLERPF in terms of RMS error and computational cost.
Table 1. Comparison of QMRPF-UKF with MLERPF in terms of RMS error and computational cost.
Threshold of QMRPF-UKFMLERPF
1 × 10−55 × 10−57 × 10−51.3 × 10−41.7 × 10−41.9 × 10−45 × 10−4
RMS error (°)0.01150.01370.01280.01080.01340.01240.01260.020
Computational cost (s)2232212191941801711601840

Share and Cite

MDPI and ACS Style

Cui, P.; Zhang, H. QMRPF-UKF Master-Slave Filtering for the Attitude Determination of Micro-Nano Satellites Using Gyro and Magnetometer. Sensors 2010, 10, 9935-9947. https://doi.org/10.3390/s101109935

AMA Style

Cui P, Zhang H. QMRPF-UKF Master-Slave Filtering for the Attitude Determination of Micro-Nano Satellites Using Gyro and Magnetometer. Sensors. 2010; 10(11):9935-9947. https://doi.org/10.3390/s101109935

Chicago/Turabian Style

Cui, Peiling, and Huijuan Zhang. 2010. "QMRPF-UKF Master-Slave Filtering for the Attitude Determination of Micro-Nano Satellites Using Gyro and Magnetometer" Sensors 10, no. 11: 9935-9947. https://doi.org/10.3390/s101109935

Article Metrics

Back to TopTop