Low-complexity widely linear RLS filter using DCD iterations

Size: px
Start display at page:

Download "Low-complexity widely linear RLS filter using DCD iterations"

Transcription

1 XXX SMPÓSO BASLEO DE TELECOMUNCAÇÕES - SBrT 12, DE SETEMBO DE 212, BASÍLA, DF Low-complexity widely linear LS filter using DCD iterations Ferno G. Almeida Neto, Vítor H. Nascimento Yuriy V. Zakharov esumo ecentemente, filtros adaptativos amplamente lineares estão sendo usados para acessar completamente estatísticas de segunda ordem de sinais impróprios, com o objetivo de melhorar a estimação. Essa característica torna esses filtros vantajosos em relação aos seus equivalentes estritamente lineares, apesar de apresentarem maior complexidade computacional. Nesse sentido, com o intuito de reduzir o custo computacional do LS amplamente linear (WL-LS), em um artigo anterior foi proposta uma versão de complexidade reduzida que foi chamada de C-WL-LS e que apresentou um quarto da complexidade computacional do WL-LS. Contudo, o algoritmo obtido ainda manteve complexidade O(N 2 ) (em que N representa o comprimento do vetor regressor). No presente trabalho, o C-WL-LS é modificado e é proposta uma modificação do algoritmo dichotomous coordinate descent (DCD) para iterativamente resolver as equações normais. Com essa abordagem, o número de multiplicações por iteração é reduzido e um algoritmo numericamente estável e de complexidade linear com N é obtido. Simulações são realizadas para comprovar o funcionamento do algoritmo proposto. Palavras-Chave Estimação amplamente linear, Estimação com complexidade reduzida, Algoritmo LS amplamente linear de complexidade reduzida, Algoritmo dichotomous coordinate descent (DCD) Abstract Widely linear (WL) adaptive filters have been receiving much attention recently, since they take advantage of the full second-order statistics of improper signals. While this approach provides estimation gains if compared to their strictly linear (SL) counterparts, WL algorithms generally present higher computational complexity. n order to reduce the computational cost, we presented in a previous paper a reduced-complexity (C) version of the WL-LS algorithm the C-WL-LS algorithm which was shown to be 4 times less expensive than the WL- LS, but still keeps the O(N 2 ) complexity ( N is the length of the regressor vector). n this paper, we modify the C- WL-LS, applying the dichotomous coordinate descent (DCD) algorithm to iteratively solve the normal equations. With this approach, we reduce the number of multiplications per iteration obtain a numerically stable widely-linear LS algorithm with computational complexity linear on N. Simulations are presented to support our approach. Keywords Widely linear estimation, educed-complexity estimation, educed-complexity widely linear LS, Dichotomous coordinate descent (DCD) algorithm. NTODUCTON t is well-known that the ecursive Least-Squares (LS) algorithm 1] converges faster than the Least Mean-Squares (LMS) algorithm 1], that the LS is also less sensitive Ferno G. Almeida Neto Vítor H. Nascimento are with the Dept. of Eletronic Systems, Escola Politécnica of the Univeristy of São Paulo, São Paulo, SP, Brasil. {fganeto, vitor}@lps.usp.br. Yuriy V. Zakharov is with the Dept. of Electronics of the University of York, York, U.K.. yury.zakharov@york.ac.uk to the spread of the eigenvalues in the covariance matrix. However, while the LMS presents linear computational cost, the LS complexity is quadratic with the regressor vector length (O(N 2 )). Moreover, the LS algorithm also suffers with numerical instability, requiring more care during the implementation in order to avoid divergence. The computational cost is also aggravated if we use a widely linear (WL) LS algorithm 2]. n this case, the length of the regressor vector is duplicated to use both the complex data their conjugate, which provides smaller mean-square error (MSE) for improper (or non-circular) input 3]. This approach is used to account for full second-order statistics of improper signals achieve better estimation. n order to reduce the complexity of the WL-LS, a reduced-complexity (C) version of the WL-LS was proposed in 4]. n that paper, a linear transformation was used to obtain an algorithm with exactly the same performance, but with a complexity of one-fourth the complexity of the WL-LS. Although it was shown that the C-WL-LS has complexity similar to the strictly linear (SL) LS algorithm, the cost was still O(N 2 ) the numerical stability still remained unsolved. (See Table to compare the number of real operations per iteration of the algorithms, we call strictly linear (SL) LS the traditional complex LS algorithm.) Note that the quadratic cost of the algorithms comes from the update of the inverse autocorrelation matrix. n 5] 6], the dichotomous coordinate descent (DCD) was proposed as an alternative to iteratively solve the normal equations. t was shown in 7] that the DCD is an efficient stable alternative to implement the LS algorithm in FPGAs, since this algorithm uses less multiplications to solve the normal equations, less multipliers lead to the reduction of the consumed area. The DCD is particularly attractive for the reason that one can obtain an LS algorithm with complexity proportional to N. Moreover, since the DCD-LS does not propagate the inverse autocorrelation matrix, it does not suffer from numerical instability. n this paper we modify the DCD algorithm to use with the C-WL-LS. As a result, we obtain an algorithm that presents low-complexity that is, linear on N which is numerically stable. We compare the obtained algorithm (the DCD-WL-LS) with the C-WL-LS show that the new approach provides a low-complexity algorithm with almost the same performance of the C-WL-LS, which is supported by our simulations. This paper is organized as follows: Section presents the C-WL-LS algorithm. n Section we modify the C-

2 XXX SMPÓSO BASLEO DE TELECOMUNCAÇÕES - SBrT 12, DE SETEMBO DE 212, BASÍLA, DF WL-LS to obtain the DCD-WL-LS. n Section V, we present the version of DCD algorithm used here. Simulations comparing the algorithms are performed in Section V, we conclude the paper in Section V.. THE C-WL-LS ALGOTHM The C-WL-LS was first presented in 4] as a reducedcomplexity version of the WL-LS algorithm. The main difference between those algorithms is that using the linear transformation U = 1 j 1 j ] N, j = 1, N is the N-order identity matrix represents the Kronecker product 8], we can modify the complex WL-LS regressor vector ] s (k)+js s WL (k) = (k) s (k) js (k) to the real C-WL-LS regressor s C (k) = s T (k) st (k) ] T, s (n) s (n) are N 1 vectors containing the real the imaginary parts of the data, respectively. n this case, using a real regressor vector, we replace many complexcomplex multiplications (which cost 4 real multiplications 2 real sums each) by real-complex multiplications (which cost only 2 real multiplications each), reducing the complexity. n 4], it is shown that both the algorithms achieve exactly the same performance, since UU H /4 = 2N. Thus, the C-WL- LS is able to use full second-order statistics, but with reduced complexity. The algorithm is summarized in Table. nitialization w C () = 2N 1 P C () = δ 2N TABLE C-WL-LS ALGOTHM for k =,1,... γ C (k) = (λ C +s H C (k)p C(k)s C (k)) 1 k C (k) = P C (k)s C (k)γ C (k) e C (k) = d(k) w H C (k)s C(k) w C (k +1) = w C (k)+k C (k)e C (k) P C (k +1) = 1 λ C PC (k)+k C (k)k H C (n)γ C(k) ] Note that d(k) is the desired signal e C (k) is the estimation error. w C (k) is a vector containing the coefficient estimates, while P C (k) is the estimate of the inverse covariance matrix. We call k C (k) the Kalman gain λ C γ C (k) are the forgetting factor the conversion factor, respectively. We use an identity matrix multiplied by a small constantδ to initialize P C (), w C () is initialized with a zero-vector. From Table, we present the computational complexity of this algorithm, one could think that, besides the complexity reduction of the C-WL-LS, one could do better, since the algorithm is still quadratic in the complexity. n Section we present the DCD-WL-LS algorithm, which presents still lower computational complexity.. THE DCD-WL-LS ALGOTHM n this section, we modify the transversal DCD-LS proposed in 7] to develop our DCD-WL-LS with linear complexity cost. We assume in this paper that both s (k) s (k) are tap-delay lines, i.e., s (k) = s (k) s (k 1) s (k N +1) ] T s (k) = s (k) s (k 1) s (k N +1) ] T, respectively. Sinces WL (k) is composed of two tap-delay lines, the fast algorithm in 7] cannot be directly used. We show below how the DCD-LS can be modified to work with WL data in the present situation. When we deal with the C-WL-LS algorithm, for each k iteration we want to find the solution for the normal equations (k) = (k) = w(k)β(k), (1) λ k i s C (i)s T C(i) = λ(k 1)+s C (k)s T C(k) (2) is the 2N 2N correlation matrix λ is the forgetting factor. (k) is real symmetric. β(n) is a vector given by β(k) = λ k i d(i)s C (i) = λβ(k 1)+d(k)s C (k). (3) We can write eq. (2) as ] (k) (k) = (k) T (k), (k) (k) = λ k i s (i)s T (i) = λ (k 1)+s (k)s T (k), (k) = (k) = (4) λ k i s (i)s T (i) = λ (k 1)+s (k)s T (k), (5) λ k i s (i)s T (i) = λ (k 1)+s (k)s T (k) (6) are N N matrices. Note that (k) (k) are symmetric matrices, but (k) is not symmetric in general. (k) (k) can be evaluated using the low-cost update proposed in 7]: (k) = r (k) ρ T (k) ρ (k) (1:N 1,1:N 1) (k 1) ], (7) the notation (1:N 1,1:N 1) (k 1) sts for a matrix with the elements of (k 1) from row 1 to N 1 from column 1 to N 1. r (k) is a real number ρ (k) is an (N 1) 1 vector. From eq. (7), we note that we only need to update the first column of (k), since we already have (1:N 1,1:N 1) (k 1) from the last iteration (k) is symmetric. n order to obtain the first row of (k) we

3 XXX SMPÓSO BASLEO DE TELECOMUNCAÇÕES - SBrT 12, DE SETEMBO DE 212, BASÍLA, DF only need to copy the values of the first column. Thus, we calculate only the first column of (k) that is (1:N,1) (k) to update eq. (7), i.e., (1:N,1) (k) = λ (1:N,1) (k 1)+s (k)s (k). Similarly, we update the first column of eq. (5) using (1:N,1) (k) = λ (1:N,1) (k 1)+s (k)s (k). n order to update (k), we write (6) as the matrix r (k) ρ T (k) = (k) ] ρ (k) (1:N 1,1:N 1), (8) (k 1) (1:N 1,1:N 1) r (k) = ρ (k) = ρ (k) = λ k i s (i)s (i), λ k i s (i)s (i 1), (9) λ k i s (i)s (i 1) (1) (k 1) = = λ k i s (1:N 1) k 1 = λ k i s (2:N) = (2:N,2:N) (k). (i 1)s (1:N 1) (i)s (2:N) (i) (i i) (11) Note from eq. (11) that (1:N 1,1:N 1) (k 1) is a block matrix obtained from iteration k 1, which does not need to be updated. Equations (9) (1) show that, in general ρ ρ, which means that they need to be calculated separately. To obtain the first column of (k), we define the column vector (1:N,1) (k) = r (k) ρ T (k) ] T = k λk i s (i)s (i) = k 1 λk i s (i)s (i)+s (k)s (k) = λ (1:N,1) (k 1)+s (k)s (k), (12) which is recursively updated. The first row of (k) is updated in a similar manner, i.e., (1,2:N) (k) = λ (1,2:N) (k 1)+s (k)s (2:N)T (k). (13) Note that in eq. (13) we do not calculate the first element of the row, since it is already computed in eq. (12). Using this approach, we can calculate matrix (k) with the update of three N N block-matrices. ecall that for each blockmatrix, we only need to update the first row in the case of (k) (k) or the first row the first column (in the case of (k)). We use this low-cost form to update matrix (k) in the DCD-WL-LS algorithm (see Table ). Assume that we update (k) with the procedure shown before. n order to obtain the DCD-WL-LS, recall eq. (1), but in the instant k 1, i.e., (k 1) = w(k 1)β(k 1). (14) We define the residue of the normal equations, after obtaining an approximate solution ŵ(k 1), as the vector Moreover, define r(k 1) = β(k 1) (k 1)ŵ(k 1). (15) (k) = (k) (k 1), (16) β(k) = β(k) β(k 1), (17) w(k) = w(k) ŵ(k 1). (18) Substituting eqs. (16), (17) (18) in (14), after some algebra manipulation, we obtain (k) w(k) = β (k), (19) β (k) = r(k 1)+ β(k) (k)ŵ(k 1). (2) Solving equation (19) instead of (1) is a way of taking advantage of the previous solution ŵ(k 1) to reduce the complexity of the algorithm. This is due to the iterative structure of DCD solving (19) is equivalent to start DCD with ŵ(k 1) as initial condition, reducing the number of DCD iterations ( the complexity) necessary at each time instant. We apply the DCD algorithm of Table V to iteratively solve this system of equations in the DCD-WL-LS algorithm obtain the approximate solution ŵ(k) = ŵ(k 1)+ ŵ(k). (21) We can also write eq. (15) in terms of β (k) ŵ(k), using eqs. (2) (21), i.e., r(k) = β (k) (k) ŵ(k). ecall (16) (17). Using the second identity of (2) (3) in eqs. (16) (17), respectively, we can express (k) = (1 λ)(k 1)+s C (k)s T C (k) (22) β(k) = (1 λ)β (k)+d(k)s C (k). (23) Define the filter estimative y(k) = s T C (k)ŵ(k 1). Using (22) (23) in eq. (15), (k)ŵ(k 1) = = (λ 1)β(k 1) r(k 1)]+s C (k)y(k), (24) which can be used in (2) to obtain β (k) = λr(k 1)+e(k)s C (k), e(k) = d(k) y(k) corresponds to the a priori error. The DCD-WL-LS algorithm is summarized in Table,

4 XXX SMPÓSO BASLEO DE TELECOMUNCAÇÕES - SBrT 12, DE SETEMBO DE 212, BASÍLA, DF Step TABLE DCD-WL-LS ALGOTHM Equation nitialization: ŵ() = 2N 1, r 2N 1 () =, = δ N, = δ N, = N for k = 1,2,... (k) = λ (1,1:N) (k 1)+s (k)s (k) 2 (1,1:N) (k) = λ (1,1:N) (k 1)+s (k)s (k) 3 (1,1:N) (k) = λ (1,1:N) (k 1)+s (k)s (k) 4 (2:N,1) (k) = λ (2:N,1) (k 1)+s (k)s (2:N)T (k) 5 (k), (k), (k) (k) 6 y(k) = s T C (k)ŵ(k) 7 e(k) = d(k) y(k) 8 β (k) = λr(k 1)+e(k)s C (k) 9 (k) w(k) = p (k) ŵ(k), r(k) 1 ŵ(k) = ŵ(k 1)+ ŵ(k) 1 (1,1:N) we also provide the initialization of the algorithm. Note that the DCD algorithm, which is presented in Section V, is used to solve the 9 th row of Table. Table compares the complexity of the developed algorithm with the SL, WL C-WL-LS. Note that there are two lines referring to the DCD-WL-LS. The first presents the complexity considering that λ can be any real number such that < λ < 1. The second assumes that λ = 1 2 m, m N, which allows the substitution of multiplications by bit-shifts sums in steps 1, 2, 3, 4 8. N u is the maximum number of successful iterations in DCD (see Section V). TABLE COMPUTATONAL COMPLEXTY OF THE SL-LS, WL-LS, C-WL-LS AND DCD-WL-LS N TEMS OF EAL OPEATONS PE TEATON Algorithm + SL-LS 6N 2 +14N 1 7N 2 +21N +1 1 WL-LS 24N 2 +28N 1 28N 2 +42N +1 1 C-WL-LS 6N 2 +11N 8N 2 +14N +1 1 DCD-WL-LS N(8 +4N u +2M b ) 14N 2 - +N u 1 DCD-WL-LS N(14+4N u +2M b ) 8N 2 - (λ = 1 2 m ) +N u 1 V. THE DCD ALGOTHM The dichotomous coordinate descent (DCD) algorithm 5], 6] was proposed as a multiplication-free alternative to solve the least-squares (LS) problem equations 1]. The algorithm is implemented using sums bit-shift operations to avoid multiplications divisions see Table V, we present the DCD algorithm version considered in this paper. The cyclic DCD algorithm updates the solution vector ŵ in the cyclic order n = 1,...,N, which is used by the DCD- WL-LS algorithm to solve the normal equations. We assume that the elements of ŵ have amplitude such that ŵ p H ( H is a positive number) that we use M b bits to represent them. The constantα is the step-size of the DCD.N u is the maximum number of successful iterations is usually chosen as N u << N. With this approach, the algorithm updates the most significant bits first the less significant bits are updated later. Note that during the DCD operation, we have two kinds of iterations: the successful the unsuccessful iterations. The first kind occurs when the condition in step 3 is true, the updates in steps 4 6 are performed. Otherwise, the update is called unsuccessful. The computational complexity of the TABLE V DCD ALGOTHM Step Equation nitialization: ŵ = 2N 1, r = β α = H, q = for m = 1,...,M b 1 α = α/2 2 flag = for n = 1,...,2N 3 if r p > (α)/2) p,p then 4 ŵ p = ŵ p + sign(r p)α 5 r = r sign(r p)α (1:2N,1) 6 q = q +1 7 if q > N u, the algorithm stops 8 if flag = 1, then repeat step 2 DCD algorithm, presented in Table V, is a rom variable, which motivates the calculation of the worst case complexity. For the worst case, the complexity corresponds to P m = multiplications P a N(2N u + M b 1) + N u sums. ecall that this complexity is a pessimistic bound, since in general this upper bound is not reached. V. SMULATONS n this section, we compare our new DCD-WL-LS with the C-WL-LS algorithm. For this purpose, we consider the same identification system model used in 4], a non-circular signal is applied to justify the WL approach. We assume that the input signal is given by s(k) = 1 ǫ 2 s (k)+jǫs (k), s (k) s (k) are two real-valued uncorrelated complex-gaussian processes, with zero-mean variance σ 2 = σ2 = 1. We can choose ǫ between 1, the condition for circularity occurs when ǫ = 1/ 2. However, we use ǫ =.1 which corresponds to a non-circular process to perform our simulations. n figures 1 2 we assume that the optimum coefficients of the system to be identified are given by w 1 opt,i = β 1(1+cos(2π(i 3)/5) j(1+cos(2π(i 3)/1))], (25) for i = 1,2,...,5 β 1 =.432. n figure 3, in order to present the tracking performance of the DCD-WL-LS, we start the simulation with the optimum coefficients of eq. 25 after 2 iterations replace them by w 2 opt,i = β 2(1+cos(π(i 3)/5) j(1+cos(5π(i 3)/1))], (26) β 2 = β 1 /4. We assume that there is Gaussian noise η(k) added to the desired signal that the signal-to-noise ratio (SN) is 4dB. We obtain the desired signal with d(k) = e{w H opts(k)}+η(k). We define the C-WL-LS forgetting factor λ C = we initialize P C () = 1 4 1, for N = 5.

5 XXX SMPÓSO BASLEO DE TELECOMUNCAÇÕES - SBrT 12, DE SETEMBO DE 212, BASÍLA, DF For the DCD-WL-LS algorithm, we choose λ DCD equal to λ C, we defineh = 1. n our simulations, we compare the mean-square error (MSE) of the C-WL-LS the DCD-WL-LS algorithms in three situations: 1) varying the number of bits M b as 2, 4, 8 or 16 bits setting N u = 4; 2) setting M b = 16 bits choosing N u to be 1, 2, 4 or 8; 3) changing the system coefficients to verify the tracking performance of the DCD-WL-LS algorithm. We run 1 simulations to obtain the MSE as MSE = E{e 2 (k)}. Figures 1, 2 3 show the results. Note from figure 1 that for a fixed 1 C-WL-LS DCD-WL-LS(M b =2) DCD-WL-LS(M b =4) DCD-WL-LS(M b =8) DCD-WL-LS(M b =16) terations Fig. 1. MSE comparison between the C-WL-LS the DCD-WL-LS, using N u = 4 M b = 2,4,8,16, for non-circular input. 1 simulations were performed. 1 C-WL-LS DCD-WL-LS(N u=1) DCD-WL-LS(N u=2) DCD-WL-LS(N u=4) DCD-WL-LS(N u=8) terations Fig. 2. MSE comparison between the C-WL-LS the DCD-WL-LS, using M b = 16 N u = 1,2,4,8, for non-circular input.1 simulations were performed. N u, the precision of the DCD-WL-LS algorithm increases as the number of bits M b increases, when compared to the C- WL-LS implemented with Matlab precision. With this information, we can choose M b to guarantee an specific MSE of course bounded by the SN use the algorithm with the smaller number of bits necessary for a given implementation. n figure 2, we can see that for a fixed number of bits, when we increasen u, we accelerate the convergence. However, even for N u = 1, we note that the algorithm achieves a steady-state MSE similar to the C-WL-LS MSE, though 4 times slower than the C-WL-LS algorithm. n fact, when we apply the DCD to solve the normal equations, we reduce the complexity to O(N), but we pay for this reduction with the need of some more iterations to achieve the steady-state MSE. Since we can control the additional number of iterations by choosing a convenient N u, this approach can be very attractive for lowcost implementations. 1 C-WL-LS DCD-WL-LS(N u=1) DCD-WL-LS(N u=2) DCD-WL-LS(N u=4) DCD-WL-LS(N u=8) terations Fig. 3. Tracking performance of the C-WL-LS the DCD-WL-LS algorithms, when the system coefficients change. Non-circular input is used for a fixed M b = 16 N u = 1,2,4,8. 1 simulations were performed. n figure 3, we show the DCD-WL-LS algorithm subject to a modification of the system coefficients, which is used to verify the tracking performance. Note that for the different values of N u proposed, the algorithm presents approximately the same performance when the system changes. As shown in 7], the tracking performance of the DCD-WL-LS does not depend as much on N u. V. CONCLUSONS n this paper, we propose a widely-linear LS algorithm that is numerically stable (since it avoids the propagation of the inverse of the autocovariance matrix) has a computational complexity that is linear on the filter length. Our simulations showed that the modification proposed slows down the initial convergence of the algorithm, but with a smart choice of the DCD parameters, the algorithm quickly recovers the performance achieves the same steady-state MSE achieved by the C-WL-LS. The tracking performance of the DCD-WL- LS does not depend as much on N u. An analytical study of the DCD-WL-LS is still under research, since traditional tools of the LS analysis can not be applied here. EFEENCES 1] A.H. Sayed, Adaptive filters, Wiley-EEE Press, 28. 2] Jae-Jin Jeon, LS adaptation of widely linear minimum output energy algorithm for DS-CDMA systems, in Proc. of the Advanced ndustrial Conference on Telecommunications/Service Assurance with Partial ntermittent esources Conference/E-Learning on Telecommunications Workshop, July 25, pp ] B. Picinbono P. Chevalier, Widely linear estimation with complex data, EEE Transaction on Signal Processing, vol. 43, no. 8, pp , Aug ] F.G.A. Neto, V.H. Nascimento, M.T.M. Silva, educed-complexity widely linear adaptive estimation, in 7th nternational Symposium on Wireless Communication Systems, Sep. 21, pp ] Y.V. Zakharov T.C. Tozer, Multiplication-free iterative algorithm for LS problem, Electronics Letters, vol. 4, no. 9, pp , April 24. 6] Y. Zakharov, G. White, Jie Liu, Fast LS algorithm using dichotomous coordinate descent iterations, in Signals, Systems Computers. ACSSC 27. Conference ecord of the Forty-First Asilomar Conference on, Nov. 27, pp ] Y.V. Zakharov, G.P. White, Jie Liu, Low-complexity LS algorithms using dichotomous coordinate descent iterations, EEE Transaction on Signal Processing, vol. 56, no. 7, pp , July 28. 8]. A. Horn C.. Johnson, Topics in Matrix Analysis, Cambridge University Press, Cambridge, MA, 1991.

Design of Multichannel AP-DCD Algorithm using Matlab

Design of Multichannel AP-DCD Algorithm using Matlab , October 2-22, 21, San Francisco, USA Design of Multichannel AP-DCD using Matlab Sasmita Deo Abstract This paper presented design of a low complexity multichannel affine projection (AP) algorithm using

More information

RLS adaptive filter with inequality constraints

RLS adaptive filter with inequality constraints RLS adaptive filter with inequality constraints Vítor H. Nascimento, Senior Member, IEEE, and Yuriy Zakharov, Senior Member, IEEE 1 Abstract In practical implementations of estimation algorithms, designers

More information

Advance Convergence Characteristic Based on Recycling Buffer Structure in Adaptive Transversal Filter

Advance Convergence Characteristic Based on Recycling Buffer Structure in Adaptive Transversal Filter Advance Convergence Characteristic ased on Recycling uffer Structure in Adaptive Transversal Filter Gwang Jun Kim, Chang Soo Jang, Chan o Yoon, Seung Jin Jang and Jin Woo Lee Department of Computer Engineering,

More information

A Non-Iterative Approach to Frequency Estimation of a Complex Exponential in Noise by Interpolation of Fourier Coefficients

A Non-Iterative Approach to Frequency Estimation of a Complex Exponential in Noise by Interpolation of Fourier Coefficients A on-iterative Approach to Frequency Estimation of a Complex Exponential in oise by Interpolation of Fourier Coefficients Shahab Faiz Minhas* School of Electrical and Electronics Engineering University

More information

THE KALMAN FILTER IN ACTIVE NOISE CONTROL

THE KALMAN FILTER IN ACTIVE NOISE CONTROL THE KALMAN FILTER IN ACTIVE NOISE CONTROL Paulo A. C. Lopes Moisés S. Piedade IST/INESC Rua Alves Redol n.9 Lisboa, Portugal paclopes@eniac.inesc.pt INTRODUCTION Most Active Noise Control (ANC) systems

More information

TRACKING PERFORMANCE OF THE MMAX CONJUGATE GRADIENT ALGORITHM. Bei Xie and Tamal Bose

TRACKING PERFORMANCE OF THE MMAX CONJUGATE GRADIENT ALGORITHM. Bei Xie and Tamal Bose Proceedings of the SDR 11 Technical Conference and Product Exposition, Copyright 211 Wireless Innovation Forum All Rights Reserved TRACKING PERFORMANCE OF THE MMAX CONJUGATE GRADIENT ALGORITHM Bei Xie

More information

Performance Analysis of Adaptive Beamforming Algorithms for Smart Antennas

Performance Analysis of Adaptive Beamforming Algorithms for Smart Antennas Available online at www.sciencedirect.com ScienceDirect IERI Procedia 1 (214 ) 131 137 214 International Conference on Future Information Engineering Performance Analysis of Adaptive Beamforming Algorithms

More information

Adaptive Signal Processing in Time Domain

Adaptive Signal Processing in Time Domain Website: www.ijrdet.com (ISSN 2347-6435 (Online)) Volume 4, Issue 9, September 25) Adaptive Signal Processing in Time Domain Smita Chopde, Pushpa U.S 2 EXTC Department, Fr.CRIT Mumbai University Abstract

More information

Performance Analysis of Adaptive Filtering Algorithms for System Identification

Performance Analysis of Adaptive Filtering Algorithms for System Identification International Journal of Electronics and Communication Engineering. ISSN 974-166 Volume, Number (1), pp. 7-17 International Research Publication House http://www.irphouse.com Performance Analysis of Adaptive

More information

3150 IEEE TRANSACTIONS ON SIGNAL PROCESSING, VOL. 56, NO. 7, JULY X/$ IEEE

3150 IEEE TRANSACTIONS ON SIGNAL PROCESSING, VOL. 56, NO. 7, JULY X/$ IEEE 3150 IEEE TRANSACTIONS ON SIGNAL PROCESSING, VOL. 56, NO. 7, JULY 2008 Low-Complexity RLS Algorithms Using Dichotomous Coordinate Descent Iterations Yuriy V. Zakharov, Member, IEEE, George P. White, and

More information

Noise Canceller Using a New Modified Adaptive Step Size LMS Algorithm

Noise Canceller Using a New Modified Adaptive Step Size LMS Algorithm Noise Canceller Using a New Modified Adaptive Step Size LMS Algorithm THAMER M.JAMEL 1 and HAIYDER A. MOHAMED 2 1 Department of Electrical & Computer Engineering University of Missouri Columbia, MO, USA

More information

Convex combination of adaptive filters for a variable tap-length LMS algorithm

Convex combination of adaptive filters for a variable tap-length LMS algorithm Loughborough University Institutional Repository Convex combination of adaptive filters for a variable tap-length LMS algorithm This item was submitted to Loughborough University's Institutional Repository

More information

Advanced Digital Signal Processing Adaptive Linear Prediction Filter (Using The RLS Algorithm)

Advanced Digital Signal Processing Adaptive Linear Prediction Filter (Using The RLS Algorithm) Advanced Digital Signal Processing Adaptive Linear Prediction Filter (Using The RLS Algorithm) Erick L. Oberstar 2001 Adaptive Linear Prediction Filter Using the RLS Algorithm A complete analysis/discussion

More information

Joint Domain Localized Adaptive Processing with Zero Forcing for Multi-Cell CDMA Systems

Joint Domain Localized Adaptive Processing with Zero Forcing for Multi-Cell CDMA Systems Joint Domain Localized Adaptive Processing with Zero Forcing for Multi-Cell CDMA Systems Rebecca Y. M. Wong, Raviraj Adve Dept. of Electrical and Computer Engineering, University of Toronto 10 King s College

More information

Analytical Approach for Numerical Accuracy Estimation of Fixed-Point Systems Based on Smooth Operations

Analytical Approach for Numerical Accuracy Estimation of Fixed-Point Systems Based on Smooth Operations 2326 IEEE TRANSACTIONS ON CIRCUITS AND SYSTEMS I: REGULAR PAPERS, VOL 59, NO 10, OCTOBER 2012 Analytical Approach for Numerical Accuracy Estimation of Fixed-Point Systems Based on Smooth Operations Romuald

More information

PAPER Design of Optimal Array Processors for Two-Step Division-Free Gaussian Elimination

PAPER Design of Optimal Array Processors for Two-Step Division-Free Gaussian Elimination 1503 PAPER Design of Optimal Array Processors for Two-Step Division-Free Gaussian Elimination Shietung PENG and Stanislav G. SEDUKHIN Nonmembers SUMMARY The design of array processors for solving linear

More information

Effects of Weight Approximation Methods on Performance of Digital Beamforming Using Least Mean Squares Algorithm

Effects of Weight Approximation Methods on Performance of Digital Beamforming Using Least Mean Squares Algorithm IOSR Journal of Electrical and Electronics Engineering (IOSR-JEEE) e-issn: 2278-1676,p-ISSN: 2320-3331,Volume 6, Issue 3 (May. - Jun. 2013), PP 82-90 Effects of Weight Approximation Methods on Performance

More information

Adaptive Filtering using Steepest Descent and LMS Algorithm

Adaptive Filtering using Steepest Descent and LMS Algorithm IJSTE - International Journal of Science Technology & Engineering Volume 2 Issue 4 October 2015 ISSN (online): 2349-784X Adaptive Filtering using Steepest Descent and LMS Algorithm Akash Sawant Mukesh

More information

Towards Spatially Universal Adaptive Diffusion Networks

Towards Spatially Universal Adaptive Diffusion Networks GlobalSIP 0: Network Theory Towards Spatially Universal Adaptive Diffusion Networks Cássio G. Lopes, Luiz F. O. Chamon, and Vítor H. Nascimento Dept. of Electronic Systems Engineering, University of São

More information

THE RECURSIVE HESSIAN SKETCH FOR ADAPTIVE FILTERING. Robin Scheibler and Martin Vetterli

THE RECURSIVE HESSIAN SKETCH FOR ADAPTIVE FILTERING. Robin Scheibler and Martin Vetterli THE RECURSIVE HESSIAN SKETCH FOR ADAPTIVE FILTERING Robin Scheibler and Martin Vetterli School of Computer and Communication Sciences École Polytechnique Fédérale de Lausanne (EPFL), CH-1015 Lausanne,

More information

PERFORMANCE OF THE DISTRIBUTED KLT AND ITS APPROXIMATE IMPLEMENTATION

PERFORMANCE OF THE DISTRIBUTED KLT AND ITS APPROXIMATE IMPLEMENTATION 20th European Signal Processing Conference EUSIPCO 2012) Bucharest, Romania, August 27-31, 2012 PERFORMANCE OF THE DISTRIBUTED KLT AND ITS APPROXIMATE IMPLEMENTATION Mauricio Lara 1 and Bernard Mulgrew

More information

Recursive Total Least-Squares Algorithm Based on Inverse Power Method and Dichotomous Coordinate-Descent Iterations

Recursive Total Least-Squares Algorithm Based on Inverse Power Method and Dichotomous Coordinate-Descent Iterations 1 Recursive Total Least-Squares Algorithm Based on Inverse Power Method Dichotomous Coordinate-Descent Iterations Reza Arablouei Member IEEE Kutluyıl Doğançay Senior Member IEEE Stefan Werner Senior Member

More information

Analysis of a Reduced-Communication Diffusion LMS Algorithm

Analysis of a Reduced-Communication Diffusion LMS Algorithm Analysis of a Reduced-Communication Diffusion LMS Algorithm Reza Arablouei a (corresponding author), Stefan Werner b, Kutluyıl Doğançay a, and Yih-Fang Huang c a School of Engineering, University of South

More information

Adaptive Filters Algorithms (Part 2)

Adaptive Filters Algorithms (Part 2) Adaptive Filters Algorithms (Part 2) Gerhard Schmidt Christian-Albrechts-Universität zu Kiel Faculty of Engineering Electrical Engineering and Information Technology Digital Signal Processing and System

More information

Clustering: Classic Methods and Modern Views

Clustering: Classic Methods and Modern Views Clustering: Classic Methods and Modern Views Marina Meilă University of Washington mmp@stat.washington.edu June 22, 2015 Lorentz Center Workshop on Clusters, Games and Axioms Outline Paradigms for clustering

More information

Modern Methods of Data Analysis - WS 07/08

Modern Methods of Data Analysis - WS 07/08 Modern Methods of Data Analysis Lecture XV (04.02.08) Contents: Function Minimization (see E. Lohrmann & V. Blobel) Optimization Problem Set of n independent variables Sometimes in addition some constraints

More information

Unconstrained Beamforming : A Versatile Approach.

Unconstrained Beamforming : A Versatile Approach. Unconstrained Beamforming : A Versatile Approach. Monika Agrawal Centre for Applied Research in Electronics, IIT Delhi October 11, 2005 Abstract Adaptive beamforming is minimizing the output power in constrained

More information

LOW-DENSITY PARITY-CHECK (LDPC) codes [1] can

LOW-DENSITY PARITY-CHECK (LDPC) codes [1] can 208 IEEE TRANSACTIONS ON MAGNETICS, VOL 42, NO 2, FEBRUARY 2006 Structured LDPC Codes for High-Density Recording: Large Girth and Low Error Floor J Lu and J M F Moura Department of Electrical and Computer

More information

JPEG compression of monochrome 2D-barcode images using DCT coefficient distributions

JPEG compression of monochrome 2D-barcode images using DCT coefficient distributions Edith Cowan University Research Online ECU Publications Pre. JPEG compression of monochrome D-barcode images using DCT coefficient distributions Keng Teong Tan Hong Kong Baptist University Douglas Chai

More information

Fixed Point LMS Adaptive Filter with Low Adaptation Delay

Fixed Point LMS Adaptive Filter with Low Adaptation Delay Fixed Point LMS Adaptive Filter with Low Adaptation Delay INGUDAM CHITRASEN MEITEI Electronics and Communication Engineering Vel Tech Multitech Dr RR Dr SR Engg. College Chennai, India MR. P. BALAVENKATESHWARLU

More information

CO-PRIME ARRAY PROCESSING WITH SUM AND DIFFERENCE CO-ARRAY

CO-PRIME ARRAY PROCESSING WITH SUM AND DIFFERENCE CO-ARRAY CO-PRIME ARRAY PROCESSING WITH SUM AND DIFFERENCE CO-ARRAY Xiaomeng Wang 1, Xin Wang 1, Xuehong Lin 1,2 1 Department of Electrical and Computer Engineering, Stony Brook University, USA 2 School of Information

More information

ISSN (Online), Volume 1, Special Issue 2(ICITET 15), March 2015 International Journal of Innovative Trends and Emerging Technologies

ISSN (Online), Volume 1, Special Issue 2(ICITET 15), March 2015 International Journal of Innovative Trends and Emerging Technologies VLSI IMPLEMENTATION OF HIGH PERFORMANCE DISTRIBUTED ARITHMETIC (DA) BASED ADAPTIVE FILTER WITH FAST CONVERGENCE FACTOR G. PARTHIBAN 1, P.SATHIYA 2 PG Student, VLSI Design, Department of ECE, Surya Group

More information

Spatio-Temporal Stereo Disparity Integration

Spatio-Temporal Stereo Disparity Integration Spatio-Temporal Stereo Disparity Integration Sandino Morales and Reinhard Klette The.enpeda.. Project, The University of Auckland Tamaki Innovation Campus, Auckland, New Zealand pmor085@aucklanduni.ac.nz

More information

ON SOME METHODS OF CONSTRUCTION OF BLOCK DESIGNS

ON SOME METHODS OF CONSTRUCTION OF BLOCK DESIGNS ON SOME METHODS OF CONSTRUCTION OF BLOCK DESIGNS NURNABI MEHERUL ALAM M.Sc. (Agricultural Statistics), Roll No. I.A.S.R.I, Library Avenue, New Delhi- Chairperson: Dr. P.K. Batra Abstract: Block designs

More information

Iterative Algorithms I: Elementary Iterative Methods and the Conjugate Gradient Algorithms

Iterative Algorithms I: Elementary Iterative Methods and the Conjugate Gradient Algorithms Iterative Algorithms I: Elementary Iterative Methods and the Conjugate Gradient Algorithms By:- Nitin Kamra Indian Institute of Technology, Delhi Advisor:- Prof. Ulrich Reude 1. Introduction to Linear

More information

Cluster Analysis. Mu-Chun Su. Department of Computer Science and Information Engineering National Central University 2003/3/11 1

Cluster Analysis. Mu-Chun Su. Department of Computer Science and Information Engineering National Central University 2003/3/11 1 Cluster Analysis Mu-Chun Su Department of Computer Science and Information Engineering National Central University 2003/3/11 1 Introduction Cluster analysis is the formal study of algorithms and methods

More information

High Order Super Nested Arrays

High Order Super Nested Arrays High Order Super Nested Arrays Chun-Lin Liu 1 and P. P. Vaidyanathan 2 Dept. of Electrical Engineering, MC 136-93 California Institute of Technology, Pasadena, CA 91125, USA cl.liu@caltech.edu 1, ppvnath@systems.caltech.edu

More information

Optimized Variable Step Size Normalized LMS Adaptive Algorithm for Echo Cancellation

Optimized Variable Step Size Normalized LMS Adaptive Algorithm for Echo Cancellation International Journal on Recent and Innovation Trends in Computing and Communication ISSN: 3-869 Optimized Variable Step Size Normalized LMS Adaptive Algorithm for Echo Cancellation Deman Kosale, H.R.

More information

FMA901F: Machine Learning Lecture 3: Linear Models for Regression. Cristian Sminchisescu

FMA901F: Machine Learning Lecture 3: Linear Models for Regression. Cristian Sminchisescu FMA901F: Machine Learning Lecture 3: Linear Models for Regression Cristian Sminchisescu Machine Learning: Frequentist vs. Bayesian In the frequentist setting, we seek a fixed parameter (vector), with value(s)

More information

Realization of Hardware Architectures for Householder Transformation based QR Decomposition using Xilinx System Generator Block Sets

Realization of Hardware Architectures for Householder Transformation based QR Decomposition using Xilinx System Generator Block Sets IJSTE - International Journal of Science Technology & Engineering Volume 2 Issue 08 February 2016 ISSN (online): 2349-784X Realization of Hardware Architectures for Householder Transformation based QR

More information

Assignment 2. Classification and Regression using Linear Networks, Multilayer Perceptron Networks, and Radial Basis Functions

Assignment 2. Classification and Regression using Linear Networks, Multilayer Perceptron Networks, and Radial Basis Functions ENEE 739Q: STATISTICAL AND NEURAL PATTERN RECOGNITION Spring 2002 Assignment 2 Classification and Regression using Linear Networks, Multilayer Perceptron Networks, and Radial Basis Functions Aravind Sundaresan

More information

CHAPTER 3 MODELING OF DEAERATOR AND SIMULATION OF FAULTS

CHAPTER 3 MODELING OF DEAERATOR AND SIMULATION OF FAULTS 27 CHAPTER 3 MODELING OF DEAERATOR AND SIMULATION OF FAULTS 3.1 INTRODUCTION Modeling plays an important role in the prediction and assessment of plant performance. There are two ways of getting the model

More information

Artificial Intelligence for Robotics: A Brief Summary

Artificial Intelligence for Robotics: A Brief Summary Artificial Intelligence for Robotics: A Brief Summary This document provides a summary of the course, Artificial Intelligence for Robotics, and highlights main concepts. Lesson 1: Localization (using Histogram

More information

Unbiased Model Combinations for Adaptive Filtering

Unbiased Model Combinations for Adaptive Filtering IEEE TRANSACTIONS ON SIGNAL PROCESSING, VOL. 58, NO. 8, AUGUST 2010 4421 [21] I. S. Chong and A. Ortega, Dynamic voltage scaling algorithms for power constrained motion estimation, in Proc. IEEE Int. Conf.

More information

Reduced Complexity Decision Feedback Channel Equalizer using Series Expansion Division

Reduced Complexity Decision Feedback Channel Equalizer using Series Expansion Division Reduced Complexity Decision Feedback Channel Equalizer using Series Expansion Division S. Yassin, H. Tawfik Department of Electronics and Communications Cairo University Faculty of Engineering Cairo, Egypt

More information

A NEW CONSTRUCTIVE HEURISTIC METHOD FOR MINIMIZING MAKESPAN IN PERMUTATION FLOW SHOP SCHEDULING

A NEW CONSTRUCTIVE HEURISTIC METHOD FOR MINIMIZING MAKESPAN IN PERMUTATION FLOW SHOP SCHEDULING A NEW CONSTRUCTIVE HEURISTIC METHOD FOR MINIMIZING MAKESPAN IN PERMUTATION FLOW SHOP SCHEDULING Marcelo Seido Nagano Faculdade de Economia, Administração e Contabilidade, Universidade de São Paulo Av.

More information

BLIND EQUALIZATION BY SAMPLED PDF FITTING

BLIND EQUALIZATION BY SAMPLED PDF FITTING BLIND EQUALIZATION BY SAMPLED PDF FITTING M. Lázaro, I. Santamaría, C. Pantaleón DICOM, ETSIIT, Univ. of Cantabria Av Los Castros s/n, 39 Santander, Spain {marce,nacho,carlos}@gtas.dicom.unican.es D. Erdogmus,

More information

ITERATIVE COLLISION RESOLUTION IN WIRELESS NETWORKS

ITERATIVE COLLISION RESOLUTION IN WIRELESS NETWORKS ITERATIVE COLLISION RESOLUTION IN WIRELESS NETWORKS An Undergraduate Research Scholars Thesis by KATHERINE CHRISTINE STUCKMAN Submitted to Honors and Undergraduate Research Texas A&M University in partial

More information

Interlaced Column-Row Message-Passing Schedule for Decoding LDPC Codes

Interlaced Column-Row Message-Passing Schedule for Decoding LDPC Codes Interlaced Column-Row Message-Passing Schedule for Decoding LDPC Codes Saleh Usman, Mohammad M. Mansour, Ali Chehab Department of Electrical and Computer Engineering American University of Beirut Beirut

More information

FPGA IMPLEMENTATION OF AN EFFICIENT PROPORTIONATE AFFINE PROJECTION ALGORITHM FOR ECHO CANCELLATION

FPGA IMPLEMENTATION OF AN EFFICIENT PROPORTIONATE AFFINE PROJECTION ALGORITHM FOR ECHO CANCELLATION 19th European Signal Processing Conference (EUSIPCO 211) Barcelona, Spain, August 29 - September 2, 211 FPGA IMPLEMENTATION OF AN EFFICIENT PROPORTIONATE AFFINE PROJECTION ALGORITHM FOR ECHO CANCELLATION

More information

Image Compression: An Artificial Neural Network Approach

Image Compression: An Artificial Neural Network Approach Image Compression: An Artificial Neural Network Approach Anjana B 1, Mrs Shreeja R 2 1 Department of Computer Science and Engineering, Calicut University, Kuttippuram 2 Department of Computer Science and

More information

Lecture 27: Fast Laplacian Solvers

Lecture 27: Fast Laplacian Solvers Lecture 27: Fast Laplacian Solvers Scribed by Eric Lee, Eston Schweickart, Chengrun Yang November 21, 2017 1 How Fast Laplacian Solvers Work We want to solve Lx = b with L being a Laplacian matrix. Recall

More information

Modelling, migration, and inversion using Linear Algebra

Modelling, migration, and inversion using Linear Algebra Modelling, mid., and inv. using Linear Algebra Modelling, migration, and inversion using Linear Algebra John C. Bancroft and Rod Blais ABSRAC Modelling migration and inversion can all be accomplished using

More information

Design and Research of Adaptive Filter Based on LabVIEW

Design and Research of Adaptive Filter Based on LabVIEW Sensors & ransducers, Vol. 158, Issue 11, November 2013, pp. 363-368 Sensors & ransducers 2013 by IFSA http://www.sensorsportal.com Design and Research of Adaptive Filter Based on LabVIEW Peng ZHOU, Gang

More information

WAVELET USE FOR IMAGE RESTORATION

WAVELET USE FOR IMAGE RESTORATION WAVELET USE FOR IMAGE RESTORATION Jiří PTÁČEK and Aleš PROCHÁZKA 1 Institute of Chemical Technology, Prague Department of Computing and Control Engineering Technicka 5, 166 28 Prague 6, Czech Republic

More information

A substructure based parallel dynamic solution of large systems on homogeneous PC clusters

A substructure based parallel dynamic solution of large systems on homogeneous PC clusters CHALLENGE JOURNAL OF STRUCTURAL MECHANICS 1 (4) (2015) 156 160 A substructure based parallel dynamic solution of large systems on homogeneous PC clusters Semih Özmen, Tunç Bahçecioğlu, Özgür Kurç * Department

More information

HIGH RESOLUTION STACKING OF SEISMIC DATA. Marcos Ricardo Covre, Tiago Barros and Renato da Rocha Lopes

HIGH RESOLUTION STACKING OF SEISMIC DATA. Marcos Ricardo Covre, Tiago Barros and Renato da Rocha Lopes HIGH RESOLUTION STACKING OF SEISMIC DATA Marcos Ricardo Covre, Tiago Barros and Renato da Rocha Lopes School of Electrical and Computer Engineering, University of Campinas DSPCom Laboratory, Department

More information

FPGA Design, Implementation and Analysis of Trigonometric Generators using Radix 4 CORDIC Algorithm

FPGA Design, Implementation and Analysis of Trigonometric Generators using Radix 4 CORDIC Algorithm International Journal of Microcircuits and Electronic. ISSN 0974-2204 Volume 4, Number 1 (2013), pp. 1-9 International Research Publication House http://www.irphouse.com FPGA Design, Implementation and

More information

Distributed Detection in Sensor Networks: Connectivity Graph and Small World Networks

Distributed Detection in Sensor Networks: Connectivity Graph and Small World Networks Distributed Detection in Sensor Networks: Connectivity Graph and Small World Networks SaeedA.AldosariandJoséM.F.Moura Electrical and Computer Engineering Department Carnegie Mellon University 5000 Forbes

More information

THE CLASSICAL method for training a multilayer feedforward

THE CLASSICAL method for training a multilayer feedforward 930 IEEE TRANSACTIONS ON NEURAL NETWORKS, VOL. 10, NO. 4, JULY 1999 A Fast U-D Factorization-Based Learning Algorithm with Applications to Nonlinear System Modeling and Identification Youmin Zhang and

More information

DS Machine Learning and Data Mining I. Alina Oprea Associate Professor, CCIS Northeastern University

DS Machine Learning and Data Mining I. Alina Oprea Associate Professor, CCIS Northeastern University DS 4400 Machine Learning and Data Mining I Alina Oprea Associate Professor, CCIS Northeastern University September 20 2018 Review Solution for multiple linear regression can be computed in closed form

More information

A Ripple Carry Adder based Low Power Architecture of LMS Adaptive Filter

A Ripple Carry Adder based Low Power Architecture of LMS Adaptive Filter A Ripple Carry Adder based Low Power Architecture of LMS Adaptive Filter A.S. Sneka Priyaa PG Scholar Government College of Technology Coimbatore ABSTRACT The Least Mean Square Adaptive Filter is frequently

More information

Hardware Implementation for the Echo Canceller System based Subband Technique using TMS320C6713 DSP Kit

Hardware Implementation for the Echo Canceller System based Subband Technique using TMS320C6713 DSP Kit Hardware Implementation for the Echo Canceller System based Subband Technique using TMS3C6713 DSP Kit Mahmod. A. Al Zubaidy Ninevah University Mosul, Iraq Sura Z. Thanoon (MSE student) School of Electronics

More information

Course Number 432/433 Title Algebra II (A & B) H Grade # of Days 120

Course Number 432/433 Title Algebra II (A & B) H Grade # of Days 120 Whitman-Hanson Regional High School provides all students with a high- quality education in order to develop reflective, concerned citizens and contributing members of the global community. Course Number

More information

Knowledge Discovery and Data Mining

Knowledge Discovery and Data Mining Knowledge Discovery and Data Mining Basis Functions Tom Kelsey School of Computer Science University of St Andrews http://www.cs.st-andrews.ac.uk/~tom/ tom@cs.st-andrews.ac.uk Tom Kelsey ID5059-02-BF 2015-02-04

More information

Implementation Of Quadratic Rotation Decomposition Based Recursive Least Squares Algorithm

Implementation Of Quadratic Rotation Decomposition Based Recursive Least Squares Algorithm 157 Implementation Of Quadratic Rotation Decomposition Based Recursive Least Squares Algorithm Manpreet Singh 1, Sandeep Singh Gill 2 1 University College of Engineering, Punjabi University, Patiala-India

More information

TEPZZ 8864Z9A_T EP A1 (19) (11) EP A1 (12) EUROPEAN PATENT APPLICATION. (51) Int Cl.: B60W 30/14 ( ) B60W 50/00 (2006.

TEPZZ 8864Z9A_T EP A1 (19) (11) EP A1 (12) EUROPEAN PATENT APPLICATION. (51) Int Cl.: B60W 30/14 ( ) B60W 50/00 (2006. (19) TEPZZ 8864Z9A_T (11) EP 2 886 9 A1 (12) EUROPEAN PATENT APPLICATION (43) Date of publication: 24.06. Bulletin /26 (1) Int Cl.: B60W /14 (06.01) B60W 0/00 (06.01) (21) Application number: 106043.7

More information

Systems of Linear Equations and their Graphical Solution

Systems of Linear Equations and their Graphical Solution Proceedings of the World Congress on Engineering and Computer Science Vol I WCECS, - October,, San Francisco, USA Systems of Linear Equations and their Graphical Solution ISBN: 98-988-95-- ISSN: 8-958

More information

PARAMETERIZATION AND SAMPLING DESIGN FOR WATER NETWORKS DEMAND CALIBRATION USING THE SINGULAR VALUE DECOMPOSITION: APPLICATION TO A REAL NETWORK

PARAMETERIZATION AND SAMPLING DESIGN FOR WATER NETWORKS DEMAND CALIBRATION USING THE SINGULAR VALUE DECOMPOSITION: APPLICATION TO A REAL NETWORK 11 th International Conference on Hydroinformatics HIC 2014, New York City, USA PARAMETERIZATION AND SAMPLING DESIGN FOR WATER NETWORKS DEMAND CALIBRATION USING THE SINGULAR VALUE DECOMPOSITION: APPLICATION

More information

Recent advances in Metamodel of Optimal Prognosis. Lectures. Thomas Most & Johannes Will

Recent advances in Metamodel of Optimal Prognosis. Lectures. Thomas Most & Johannes Will Lectures Recent advances in Metamodel of Optimal Prognosis Thomas Most & Johannes Will presented at the Weimar Optimization and Stochastic Days 2010 Source: www.dynardo.de/en/library Recent advances in

More information

THE Kalman filter has been one of the most widely used

THE Kalman filter has been one of the most widely used IEEE TRANSACTIONS ON SIGNAL PROCESSING, VOL. 55, NO. 1, JANUARY 2007 1 Information Filtering and Array Algorithms for Descriptor Systems Subject to Parameter Uncertainties Marco Henrique Terra, Member,

More information

Low-Complexity Adaptive Set-Membership Reduced-rank LCMV Beamforming

Low-Complexity Adaptive Set-Membership Reduced-rank LCMV Beamforming Low-Complexity Adaptive Set-Membership Reduced-rank LCMV Beamforming Lei Wang, Rodrigo C. de Lamare Communications Research Group, Department of Electronics University of York, York YO1 DD, UK lw1@ohm.york.ac.uk

More information

Floating Point Square Root under HUB Format

Floating Point Square Root under HUB Format Floating Point Square Root under HUB Format Julio Villalba-Moreno Dept. of Computer Architecture University of Malaga Malaga, SPAIN jvillalba@uma.es Javier Hormigo Dept. of Computer Architecture University

More information

Robust Lossless Image Watermarking in Integer Wavelet Domain using SVD

Robust Lossless Image Watermarking in Integer Wavelet Domain using SVD Robust Lossless Image Watermarking in Integer Domain using SVD 1 A. Kala 1 PG scholar, Department of CSE, Sri Venkateswara College of Engineering, Chennai 1 akala@svce.ac.in 2 K. haiyalnayaki 2 Associate

More information

Accelerating the Hessian-free Gauss-Newton Full-waveform Inversion via Preconditioned Conjugate Gradient Method

Accelerating the Hessian-free Gauss-Newton Full-waveform Inversion via Preconditioned Conjugate Gradient Method Accelerating the Hessian-free Gauss-Newton Full-waveform Inversion via Preconditioned Conjugate Gradient Method Wenyong Pan 1, Kris Innanen 1 and Wenyuan Liao 2 1. CREWES Project, Department of Geoscience,

More information

Automatic PID tuning, a heuristic optimization approach

Automatic PID tuning, a heuristic optimization approach Congreso Anual 2 de la Asociación de México de Control Automático. Puerto Vallarta, Jalisco, México. Automatic PID tuning, a heuristic optimization approach Rodrigo Abrajan-Guerrero, Luis Alejandro Marquez-Martinez

More information

Distributed Compressed Estimation Based on Compressive Sensing for Wireless Sensor Networks

Distributed Compressed Estimation Based on Compressive Sensing for Wireless Sensor Networks Distributed Compressed Estimation Based on Compressive Sensing for Wireless Sensor Networks Joint work with Songcen Xu and Vincent Poor Rodrigo C. de Lamare CETUC, PUC-Rio, Brazil Communications Research

More information

Optimal Multiuser Spread-Spectrum Data Embedding in Video Streams

Optimal Multiuser Spread-Spectrum Data Embedding in Video Streams Optimal Multiuser Spread-Spectrum Data Embedding in Video Streams Lili Wei, 1 Rose Qingyang Hu, 2 Dimitris A. Pados, 3 and Geng Wu 1 Abstract In this paper, we intend to hide multiuser data in a given

More information

Compressed Sensing Algorithm for Real-Time Doppler Ultrasound Image Reconstruction

Compressed Sensing Algorithm for Real-Time Doppler Ultrasound Image Reconstruction Mathematical Modelling and Applications 2017; 2(6): 75-80 http://www.sciencepublishinggroup.com/j/mma doi: 10.11648/j.mma.20170206.14 ISSN: 2575-1786 (Print); ISSN: 2575-1794 (Online) Compressed Sensing

More information

Kernighan/Lin - Preliminary Definitions. Comments on Kernighan/Lin Algorithm. Partitioning Without Nodal Coordinates Kernighan/Lin

Kernighan/Lin - Preliminary Definitions. Comments on Kernighan/Lin Algorithm. Partitioning Without Nodal Coordinates Kernighan/Lin Partitioning Without Nodal Coordinates Kernighan/Lin Given G = (N,E,W E ) and a partitioning N = A U B, where A = B. T = cost(a,b) = edge cut of A and B partitions. Find subsets X of A and Y of B with

More information

REGLERTEKNIK AUTOMATIC CONTROL LINKÖPING

REGLERTEKNIK AUTOMATIC CONTROL LINKÖPING An Iterative Method for Identification of ARX Models from Incomplete Data Ragnar Wallin, Alf Isaksson, and Lennart Ljung Department of Electrical Engineering Linkping University, S-81 8 Linkping, Sweden

More information

A Short SVM (Support Vector Machine) Tutorial

A Short SVM (Support Vector Machine) Tutorial A Short SVM (Support Vector Machine) Tutorial j.p.lewis CGIT Lab / IMSC U. Southern California version 0.zz dec 004 This tutorial assumes you are familiar with linear algebra and equality-constrained optimization/lagrange

More information

Multichannel Affine and Fast Affine Projection Algorithms for Active Noise Control and Acoustic Equalization Systems

Multichannel Affine and Fast Affine Projection Algorithms for Active Noise Control and Acoustic Equalization Systems 54 IEEE TRANSACTIONS ON SPEECH AND AUDIO PROCESSING, VOL. 11, NO. 1, JANUARY 2003 Multichannel Affine and Fast Affine Projection Algorithms for Active Noise Control and Acoustic Equalization Systems Martin

More information

Multi Layer Perceptron trained by Quasi Newton learning rule

Multi Layer Perceptron trained by Quasi Newton learning rule Multi Layer Perceptron trained by Quasi Newton learning rule Feed-forward neural networks provide a general framework for representing nonlinear functional mappings between a set of input variables and

More information

Projection onto the probability simplex: An efficient algorithm with a simple proof, and an application

Projection onto the probability simplex: An efficient algorithm with a simple proof, and an application Proection onto the probability simplex: An efficient algorithm with a simple proof, and an application Weiran Wang Miguel Á. Carreira-Perpiñán Electrical Engineering and Computer Science, University of

More information

A PMU-Based Three-Step Controlled Separation with Transient Stability Considerations

A PMU-Based Three-Step Controlled Separation with Transient Stability Considerations Title A PMU-Based Three-Step Controlled Separation with Transient Stability Considerations Author(s) Wang, C; Hou, Y Citation The IEEE Power and Energy Society (PES) General Meeting, Washington, USA, 27-31

More information

Relational Partitioning Fuzzy Clustering Algorithms Based on Multiple Dissimilarity Matrices

Relational Partitioning Fuzzy Clustering Algorithms Based on Multiple Dissimilarity Matrices Relational Partitioning Fuzzy Clustering Algorithms Based on Multiple Dissimilarity Matrices Francisco de A.T. de Carvalho a,, Yves Lechevallier b and Filipe M. de Melo a a Centro de Informática, Universidade

More information

Sequential Coordinate-wise Algorithm for Non-negative Least Squares Problem

Sequential Coordinate-wise Algorithm for Non-negative Least Squares Problem CENTER FOR MACHINE PERCEPTION CZECH TECHNICAL UNIVERSITY Sequential Coordinate-wise Algorithm for Non-negative Least Squares Problem Woring document of the EU project COSPAL IST-004176 Vojtěch Franc, Miro

More information

Algebraic Iterative Methods for Computed Tomography

Algebraic Iterative Methods for Computed Tomography Algebraic Iterative Methods for Computed Tomography Per Christian Hansen DTU Compute Department of Applied Mathematics and Computer Science Technical University of Denmark Per Christian Hansen Algebraic

More information

VLSI Implementation of Low Power Area Efficient FIR Digital Filter Structures Shaila Khan 1 Uma Sharma 2

VLSI Implementation of Low Power Area Efficient FIR Digital Filter Structures Shaila Khan 1 Uma Sharma 2 IJSRD - International Journal for Scientific Research & Development Vol. 3, Issue 05, 2015 ISSN (online): 2321-0613 VLSI Implementation of Low Power Area Efficient FIR Digital Filter Structures Shaila

More information

Dense Image-based Motion Estimation Algorithms & Optical Flow

Dense Image-based Motion Estimation Algorithms & Optical Flow Dense mage-based Motion Estimation Algorithms & Optical Flow Video A video is a sequence of frames captured at different times The video data is a function of v time (t) v space (x,y) ntroduction to motion

More information

Multichannel Recursive-Least-Squares Algorithms and Fast-Transversal-Filter Algorithms for Active Noise Control and Sound Reproduction Systems

Multichannel Recursive-Least-Squares Algorithms and Fast-Transversal-Filter Algorithms for Active Noise Control and Sound Reproduction Systems 606 IEEE TRANSACTIONS ON SPEECH AND AUDIO PROCESSING, VOL 8, NO 5, SEPTEMBER 2000 Multichannel Recursive-Least-Squares Algorithms and Fast-Transversal-Filter Algorithms for Active Noise Control and Sound

More information

Two-Stage Least Squares

Two-Stage Least Squares Chapter 316 Two-Stage Least Squares Introduction This procedure calculates the two-stage least squares (2SLS) estimate. This method is used fit models that include instrumental variables. 2SLS includes

More information

VHDL Implementation of Multiplierless, High Performance DWT Filter Bank

VHDL Implementation of Multiplierless, High Performance DWT Filter Bank VHDL Implementation of Multiplierless, High Performance DWT Filter Bank Mr. M.M. Aswale 1, Prof. Ms. R.B Patil 2,Member ISTE Abstract The JPEG 2000 image coding standard employs the biorthogonal 9/7 wavelet

More information

Performance of Error Normalized Step Size LMS and NLMS Algorithms: A Comparative Study

Performance of Error Normalized Step Size LMS and NLMS Algorithms: A Comparative Study International Journal of Electronic and Electrical Engineering. ISSN 97-17 Volume 5, Number 1 (1), pp. 3-3 International Research Publication House http://www.irphouse.com Performance of Error Normalized

More information

A Two-Layer Spreading Code Scheme for Dual-Rate DS-CDMA Systems

A Two-Layer Spreading Code Scheme for Dual-Rate DS-CDMA Systems IEEE TRANSACTIONS ON COMMUNICATIONS, VOL. 51, NO. 6, JUNE 2003 873 A Two-Layer Spreading Code Scheme for Dual-Rate DS-CDMA Systems Yingwei Yao and H. Vincent Poor, Fellow, IEEE Abstract This letter considers

More information

New Message-Passing Decoding Algorithm of LDPC Codes by Partitioning Check Nodes 1

New Message-Passing Decoding Algorithm of LDPC Codes by Partitioning Check Nodes 1 New Message-Passing Decoding Algorithm of LDPC Codes by Partitioning Check Nodes 1 Sunghwan Kim* O, Min-Ho Jang*, Jong-Seon No*, Song-Nam Hong, and Dong-Joon Shin *School of Electrical Engineering and

More information

Concept of Curve Fitting Difference with Interpolation

Concept of Curve Fitting Difference with Interpolation Curve Fitting Content Concept of Curve Fitting Difference with Interpolation Estimation of Linear Parameters by Least Squares Curve Fitting by Polynomial Least Squares Estimation of Non-linear Parameters

More information

Efficient Gradient Method for Locally Optimizing the Periodic/Aperiodic Ambiguity Function

Efficient Gradient Method for Locally Optimizing the Periodic/Aperiodic Ambiguity Function Efficient Gradient Method for Locally Optimizing the Periodic/Aperiodic Ambiguity Function F Arlery, R assab, U Tan, F Lehmann To cite this version: F Arlery, R assab, U Tan, F Lehmann. Efficient Gradient

More information

Algebraic Iterative Methods for Computed Tomography

Algebraic Iterative Methods for Computed Tomography Algebraic Iterative Methods for Computed Tomography Per Christian Hansen DTU Compute Department of Applied Mathematics and Computer Science Technical University of Denmark Per Christian Hansen Algebraic

More information