P. Feldmann R. W. Freund. of a linear circuit via the Lanczos process [5]. This. it produces. The computational cost per order of approximation

Size: px
Start display at page:

Download "P. Feldmann R. W. Freund. of a linear circuit via the Lanczos process [5]. This. it produces. The computational cost per order of approximation"

Transcription

1 Ecient Linear Circuit Analysis by Pade Approximation via the Lanczos Process P Feldmann R W Freund AT&T Bell Laboratories AT&T Bell Laboratories Murray Hill, NJ 09{03 Murray Hill, NJ 09{03 Abstract This paper describes a highly ecient algorithm for the iterative computation of dominant poles and zeros of large linear networks The algorithm is based on a new implementation of the Pade approximation via the Lanczos process This implementation has superior numerical properties, maintains the same computational eciency as its predecessors, and provides a bound on the approximation error 1 Introduction Circuit simulation tasks, such as the accurate prediction of interconnect eects at the board and chip level, or analog circuit analysis with full accounting of parasitic elements, reuire the solution of very large linear networks The use of SPICE-like simulators, would be inecient oreven prohibitive for such large problems In the last few years, the Asymptotic Waveform Evaluation algorithm (AWE) [1, 2] based on Pade approximation [3] has emerged as the method of choice for the ecient analysis of large linear circuits AWE is based on approximating the Laplace-domain transfer function of a linear network by a reduced-order model, containing only a relatively small number of dominant poles and zeros Such reduced-order models can be used to predict the timedomain or freuency-domain response of the linear network over a predetermined range of excitation freuencies AWE, however, suers from a number of fundamental numerical limitations In particular, each run of AWE produces only a fairly small number of accurate poles The proposed remedial techniues are sometimes heuristic, hard to apply automatically, and may be computationally expensive Another shortcoming of AWE is its inability to estimate the accuracy of the approximating reduced-order model [2, ] In this paper, we introduce a new, numerically stable algorithm that computes the Pade approximation of a linear circuit via the Lanczos process [5] This algorithm, called PVL (Pade Via Lanczos), can be used to generate an arbitrary number of poles and zeros with little numerical degradation Moreover, PVL computes a uality measure for the poles and zeros it produces The computational cost per order of approximation is practically the same as for AWE The paper is organized as follows In Section 2, we review system-order reduction by Pade approximation In Section 3, we demonstrate the numerical limitations of existing algorithms In Section, we derive the new PVL algorithm and discuss some of its properties In Section 5, we present results of numerical experiments with PVL for a variety of examples 2 System Reduction by Pade Approx Using any standard circuit-euation formulation method such as modied nodal analysis, sparse tableau, etc [], a lumped, linear, time-invariant circuit can be described by the following system of rst-order dierential euations: C _x = y = l T x: Gx + bu; (1) Here, the vector x represents the circuit variables, the matrix G represents memoryless elements, such as resistors, C represents memory elements, such as capacitors and inductors, y is the output of interest, and bu represents excitations from independent sources We are interested in determining the impulse-response of the linear circuit with zero initial-conditions, which, in turn, can be used to determine the response to any excitation We apply the Laplace transform to the system (1) and obtain scx = Y = l T X; GX + bu; (2) where X, U, and Y denote the Laplace transform of x, u, and y, respectively It follows from (2) that the Permission to copy without fee all or part of this material is granted provided that the copies are not made or distributed for direct commercial advantage, the ACM copyright notice and the title of the publication and its date appear, and notice is given that copying is by permission of the Association for Computing Machinery To copy otherwise, or to republish, reuires a fee and/or specic permission (c) 199 ACM /9/

2 Laplace-domain impulse response, or transfer function, dened as H(s) =Y(s)=U(s), is given by H(s) =l T (G+sC) 1 b: (3) Let s 0 2 C be an arbitrary, but xed expansion point such that the matrix G + s 0 C is nonsingular Using the change of variables s = s 0 + and setting A = (G + s 0 C) 1 C; r =(G+s 0 C) 1 b; () we can rewrite (3) as follows: H(s 0 + ) =l T (I A) 1 r: (5) When matrix A is diagonalizable, we obtain H(s 0 + ) = {z} l T S (I ) = f T {z } = g 1 S 1 r ; () where A = SS 1, = diag( 1 ; 2 ;:::; N )isadiagonal matrix whose diagonals elements are the eigenvalues of A, and the matrix S contains the corresponding eigenvectors as columns From (), we get H(s 0 + ) = NX f j g j 1 j ; () where f j and g j are components of f and g The numerical computation of all eigenvectors and eigenvalues of the matrix A becomes prohibitive as soon as its size reaches a few hundreds, and therefore, the only practical way to obtain an expression for the impulse response is through an approximation For each pair of integers p; 0, the Pade approximation (of type (p=)) to the network impulse response H(s 0 + ) is dened as the rational function H p; (s 0 + ) = b p p ++b 1 +b 0 a ++a 1 +1 (8) whose Taylor series about = 0 agrees with the Taylor series of H(s 0 + ) in the rst p terms, ie, H p; (s 0 + ) =H(s 0 +)+O(s p++1 ): The coecients a 1 ;:::;a ;b 0 ;b 1 ;:::;b p of the Pade approximation (8) are uniuely determined by the rst p Taylor coecients of the impulse response The roots of the denominator and numerator polynomials in (8) represent the dominant poles and zeros of the system, respectively In the context of impulse-response approximations, it is very natural to choose p = 1 in (8), so that the Pade approximation is of the same form as the original impulse response In the following, we refer to H := H 1; as the th Pade approximant to the impulse response H By using a partial-fraction decomposition, we can write H in the form H (s 0 + ) = X k j p j : (9) The Taylor coecients necessary for the Pade approximant H result from the following expansion of H(s) about s 0 : H(s 0 + ) =l T where X 1 I+A+ 2 A 2 + r= m k k ; k=0 m k = l T A k r; k =0;1::: : (10) Note that in the case when the expansion point is chosen as the origin, ie, s 0 = 0, the coecients m k, are, up to a constant factor, the time-domain moments of the circuit response Because of this analogy, we will always refer to the Taylor coecients (10) as the moments of the impulse-response function H(s 0 + ) 3 Limitations of Current Algorithms In AWE, the Pade approximant H is obtained via explicit computation of the leading 2 moments, m k, of H To this end, one rst generates the vectors u 0 = r; u 1 = Ar; u 2 = A 2 r;:::;u 2 1 = A 2 1 r by recursive solution of the linear systems (G + s 0 C) u k = Cu k 1 ; k =1;2;:::;2 1; (11) with the initial vector u 0 =(G+s 0 C) 1 b Observe that the recursive computation of the vectors u k can be performed very eciently because the matrix G + s 0 C is LU-factored exactly once The moments are then computed as m k = l T u k, k =0;1;2;:::;2 1 As the next step, AWE computes the coecients of the denominator polynomial of the representation (8) of H via solution of the linear system 2 a 3 2 m 3 a M 1 m +1 a 1 5 = m ; (12) where M =[m j+k 2 ] j;k=1;2;:::; is the so-called moment matrix The poles p j of H in (9) are then obtained as the roots of the denominator polynomial Finally, the residues k j in (9) are computed by solving another linear system of order, see, eg, []

3 Voltage gain (db) Exact AWE, 2 iter AWE, 5 iter AWE, 8 iter (M ) (M (1) ) (M (2) ) (M (3) ) 2 959e+05 22e+00 22e+00 10e e+15 51e e+03 21e e+2 113e e e e+35 23e e e+10 38e+ 22e+1 238e+1 599e e e+18 18e+18 2e e+2 15e+18 50e+1 538e+1 Table 1: Condition numbers of moment matrices for simulation of voltage gain with AWE Freuency (Hz) Figure 1: Results for simulation of voltage gain with AWE As is increased, one would expect more and more accurate approximations H of the exact impulse response H Unfortunately, this is not the case when the Pade approximant H is generated with AWE Indeed, typically H improves only for values of up to about 10, and after that the process stagnates Figure 1 illustrates this behavior Here, we tried to simulate the voltage gain of a lter with our own implementation of AWE written in MATLAB TM [] We show the exact voltage gain and the approximations generated by AWE for =2;5;8 The results for >8 showed no further improvement The severe numerical problems with the AWE approach of obtaining Pade approximants via direct computation of the moments can be explained as follows The generation of the vectors u k = A k r in (11) corresponds to vector iteration with the matrix A, and this process converges rapidly to an eigenvector corresponding to an eigenvalue of A with largest absolute value As a result, the moments m k = l T u k contain only information corresponding to one eigenvalue of A, even for fairly small values of k As a result, the moment matrix M becomes rapidly ill-conditioned The condition number, (M ), of the matrix M is a measure for how round-o error aects the accuracy of the numerically computed solution of (12) Each increase of (M )by a factor of 10 signals the loss of one decimal digit of accuracy in the computed solution In the rst column of Table 1, we list (M ) for the moment matrices corresponding to the simulation of the voltage gain of a lter Clearly, the moment matrices are extremely ill-conditioned Scaling of moments, proposed as remedy to this problem, in [2] and [], provides only a modest improvement in the matrix condition number In Table 1, we also list the condition numbers of the scaled moment matrices using three proposed scaling strategies The PVL Algorithm We now describe the PVL algorithm that exploits the intimate connection [8] between Pade approximation and the Lanczos process to elude the direct computation of the moments First, we recall the classical Lanczos process [5] and some of its key properties Algorithm 1 (Lanczos algorithm [5]) 0) Set v = r, w = l, v 0 = w 0 = 0, and 0 =1 For n =0;1;:::; do : 1) Compute n+1 = kvk 2 and n+1 = kwk 2 If n+1 =0or n+1 = 0, then stop 2) Set v n+1 = v n+1 ; w n+1 = w n+1 ; (13) n = w T nv n ; n = wt nav n n ; (1) n = n n n 1 ; n = n n n 1 ; (15) v = Av n v n n v n 1 n ; (1) w = A T w n w n n w n 1 n : (1) We remark that in Algorithm 1 a breakdown will occur if one encounters n =0oreven n 0 in (1) Therefore, our implementation of the PVL algorithm employs the look-ahead Lanczos algorithm described in [9] that remedies the breakdown problem The uantities generated by Algorithm 1 have the following properties:

4 1 The vectors fv n g +1 and fw n=1 ng +1 n=1 are biorthogonal: w T j ; if j = k, j v k = (18) 0; if j = k, for all j; k =1;2;:::;+1 Thus, setting V =[v 1 v 2 v ]; W =[w 1 w 2 w ]; wehaved =W T V = diag( 1 ; 2 ;:::; ) 2 The tridiagonal matrices ~T and T dened by T = ; ~T = satisfy ~ T T = D T D 1 3 The matrices ~T and T have the following relation to the matrix A: AV = V T +[00 v +1 ] +1 ; A T W = W ~T +[0 0w +1 ] +1 : (19) Next, we demonstrate the connection of the Lanczos process to Pade approximation Using the relations in (19) and the fact that T is tridiagonal, one can show that, for all j =0;1;:::; 1, A j r = 1 A j v 1 = 1 A j V e 1 = 1 V T j e 1 ; (20) l T A j = 1 1 e T 1 T j D 1 W T ; where e 1 =[1 0 0] T is the rst unit vector On the other hand, by (10), each moment m k can be written as follows: m k = l T A k r = lt A k0 A k00 r ; (21) where k = k 0 + k 00 If k 2 2, we can nd 0 k 0 ;k 00 1, and from (20){(21) it follows that m k = e T 1 T k0 D 1 W T V {z T } k 00 e 1 : = D Note that = l T r, and thus, from (22), we get (22) m k =(l T r) e T 1T k e 1 ; k=0;1;:::;2 2: (23) Furthermore, it can be shown that the relation (23) also holds for k =2 1 Thus, by (23), we have l T r 1X k=0 e T 1 T k e 1 k = 2 1 X k=0 m k k + O( 2 ); (2) and conseuently, H (s 0 + ) =l T re T 1 (I T ) 1 e 1 (25) is just the th Pade approximant ofh In analogy to the representation () of the exact impulse response H, we can rewrite the expression (25) of H in terms of the eigendecomposition T = S S 1 of the Lanczos matrix T : H (s 0 + ) =l T r e T 1S = X {z } = T l T r j j 1 j : (I ) 1 S 1 e 1 {z } = (2) Here, = diag( 1 ; 1 ;:::; ) contains the eigenvalues of T, and j and j are the components of the vectors and Finally, from (2), we obtain the pole/residue representation of the Pade approximant: H (s 0 + ) = X j =0 l T r j j = j 1= j : (2) The previous derivation shows that the Pade approximant H can be obtained by running the Lanczos algorithm and by computing an eigendecomposition of the Lanczos matrix T The resulting computational procedure is the PVL algorithm Algorithm 2 (Sketch of the PVL algorithm) 1) Run steps of the Lanczos process (Algorithm 1) to obtain the tridiagonal matrix T 2) Compute an eigendecomposition T = S diag( 1 ; 1 ;:::; )S 1 (28) of T, and set = S T e 1 and = S 1 e 1 3) Compute the poles and residues of H by setting p j =1= j and k j = lt r j j j j =1;2;:::: for all (29) We remark that the PVL algorithm and AWE reuire roughly the same amount of computational work Similar to AWE, the dominating cost is the computation of the LU factorization of the matrix G + s 0 C which needs to be computed only once The vectors Av n and A T w n reuired in step 2) of Algorithm 1

5 Voltage gain (db) Exact PVL, 2 iter PVL, 8 iter PVL, 28 iter Freuency (Hz) Figure 2: Results for simulation of voltage gain with PVL are then obtained using forward-backward substitutions PVL reuires 2 substitutions to generate the th Pade approximant, exactly as AWE As a rst example, we reran the simulation of the voltage gain of the lter, now with the PVL algorithm instead of AWE The results of three runs with = 2;8;28 are shown in Figure 2 In contrast to the simulation with AWE (cf Figure 1), the PVLgenerated Pade approximant for = 28 gives a perfect match of the exact voltage gain The zeros of the reduced-order model H can also be computed easily from the Lanczos matrix T In fact, it can be shown that zeros of H are just the inverses of the eigenvalues of T 0, the matrix obtained from T by deleting the rst row and column Finally, we briey sketch how the PVL algorithm can be used to obtain bounds for the pole approximation error Recall that, by (29), the poles of the th Pade approximant H are just the inverses of the eigenvalues of the Lanczos matrix T, On the other hand, in view of (), the poles of the exact impulse response H are the inverses of the eigenvalues of A Therefore, a uality measure for the poles of H can be obtained by checking how well the eigenvalues of T approximate the eigenvalues of A It can be shown that Az j j z j = v s j, where s j is the last component of the vector s j By taking norms, and since kv +1 k 2 = 1, it follows that kaz j j z j k 2 kak 2 ks j k 2 +1js j j n(a) ks j k 2 =Q j : (30) where n(a) is an estimate of kak 2, easily obtained from the algorithm Thus the number Q j represents a measure of how well the pair ( j ; z j ) approximates an eigenpair of the matrix A, and conseuently a uality measure of the approximate pole 1= j produced by the PVL algorithm Note that Q j can easily be computed from the uantities generated by PVL 5 Discussion and Examples The Pade approximation generates poles that correspond to the dominant poles of the original system and a few poles that do not correspond to poles in the original system, but account for the eects of the remaining original poles The true poles can be identied using the bound presented in Section and by comparing the poles obtained at consecutive iterations of the algorithm The true poles that have converged should not change signicantly between iterations The rst example is a lumped-element euivalent circuit for three-dimensional electromagnetic problem modeled via PEEC [10] (partial element euivalent circuit) The circuit consists of 2100 capacitors, 12 inductors, and 990 inductive couplings, resulting in a 3030 fairly dense MNA matrix The Pade approximation generated by AWE, reproduces the transferfunction of the euivalent circuit accurately up to 1GHz [11] In [12], Chiprout et al, through the use of multi-point moment matching, obtain a sucient number of accurate poles and zeros to extend the validity of the approximation up to 5GHz However, their method involves several complex circuit matrix factorizations and, therefore, is signicantly more expensive computationally We applied our PVL algorithm to the same circuit and, after 0 iterations, obtained a reduced-order system with a better match up to 5GHz than the one obtained from multi-point moment matching (Figure 3) Moreover, since PVL reuires only one real circuit matrix factorization, the cost of the computation is similar to AWE The second example models a complete power grid for a standard cell mixed signal ASIC, including some of the substrate contacts and substrate coupling/decoupling, as described in [13] The model contains 10 power bus segments, 3 models for cells, and a coarse, substrate grid The resulting MNA matrix has a size of 1 1 We are interested to determine the eects of the switching current in cells on the VDD and GND rails Figure shows the magnitude of the corresponding transfer function produced by the PVL algorithm in 50 iterations compared to the same transfer function produced by an ACsweep The agreement is perfect

6 Current (Amps) Exact PVL, 0 iter Current gain (db) AC analysis PVL, 50 iter Freuency (GHz) Freuency (Hz) Figure 3: Results for the PEEC circuit, 0 PVL iterations Conclusions This paper introduces PVL, a novel algorithm for linear circuit analysis based on the connection between the Lanczos process and the Pade approximation Its superior numerical stability allows the computation of more accurate and higher order Pade approximations with no sacrice in eciency As a conseuence the usefulness of Pade approximation based linear circuit analysis techniues is considerably extended Acknowledgments We would like to thank R Melville, R Rutenbar, H Heeb, and B Stanisic for providing us with interesting circuit examples We also acknowledge the original AWE developers, L Pillage, X Huang, and R Rohrer, who demonstrated the usefulness of the Pade approximation in the analysis of large linear circuits References [1] LT Pillage and RA Rohrer, \Asymptotic waveform evaluation for timing analysis," IEEE Trans Computer-Aided Design, vol 9, pp 352{3, Apr 1990 [2] X Huang, \Pade approximation of linear(ized) circuit responses," PhD diss, Dept of Electrical and Computer Engineering, Carnegie Mellon Univ, Pittsburgh, PA, Nov 1990 [3] GA Baker, Jr and P Graves-Morris, Pade Approximants, Part I: Basic Theory Reading, MA: Addison- Wesley, 1981 [] E Chiprout and MS Nakhla, Asymptotic Waveform Evaluation and Moment Matching for Interconnect Figure : Results for the mixed-signal circuit magnitude, 50 PVL iterations Analysis Norwell, MA: Kluwer Academic Publishers, 199 [5] C Lanczos, \An iteration method for the solution of the eigenvalue problem of linear dierential and integral operators," J Res Nat Bur Standards, vol 5, pp 255{282, 1950 [] J Vlach and K Singhal, Computer Methods for Circuit Analysis and Design New York, NY: Van Nostrand Reinhold, 1983 [] MATLAB User's Guide The MathWorks, Inc, Natick, MA, 1992 [8] WB Gragg, \Matrix interpretations and applications of the continued fraction algorithm," Rocky Mountain J Math, vol, pp 213{225, 19 [9] RW Freund, MH Gutknecht, and NM Nachtigal, \An implementation of the look-ahead Lanczos algorithm for non-hermitian matrices," SIAM J Sci Comput, vol 1, pp 13{158, Jan 1993 [10] AE Ruehli, \Euivalent circuit models for threedimensional multiconductor systems," IEEE Trans Microwave Theory and Tech, vol 22, pp 21{221, Mar 19 [11] H Heeb, AE Ruehli, JE Bracken, and RA Rohrer, \Three dimensional circuit oriented electromagnetic modeling for VLSI interconnects," in Proc Int Conf Computer Design: VLSI in Computers & Processors, Oct 1992 [12] E Chiprout, H Heeb, MS Nakhla, and AE Ruehli, \Simulating 3-D retarded interconnect models using complex freuency hopping (CFH)," in Tech Dig IEEE/ACM Int Conf Computer-Aided Design,Nov 1993 [13] BR Stanisic, RA Rutenbar, and LR Carley, \Mixed-signal noise-decoupling via simultaneous power distribution design and cell customization in rail," in Proc IEEE Custom Integrated Circuits Conf, 199

Practical Considerations For Passive Reduction of RLC Circuits

Practical Considerations For Passive Reduction of RLC Circuits Practical Considerations For Passive Reduction of RLC Circuits Altan Odabasioglu and Mustafa Celik {altan, celik}@montereydesign.com Monterey Design Systems, Inc. Sunnyvale, CA 94089 Lawrence T. Pileggi

More information

Passive reduced-order modeling via Krylov-subspace methods

Passive reduced-order modeling via Krylov-subspace methods Passive reduced-order modeling via Krylov-subspace methods Roland W. Freund Bell Laboratories Room 2C 525 700 Mountain Avenue Murray Hill, New Jersey 07974 0636, U.S.A. freund@research.bell-labs.com Keywords:

More information

Passive Reduced Order Multiport Modeling: The Padé-Laguerre, Krylov-Arnoldi-SVD Connection

Passive Reduced Order Multiport Modeling: The Padé-Laguerre, Krylov-Arnoldi-SVD Connection Passive Reduced Order Multiport Modeling: The Padé-Laguerre, Krylov-Arnoldi-SVD Connection Luc Knockaert and Daniel De Zutter 1 Abstract A reduced order multiport modeling algorithm based on the decomposition

More information

EE5900 Spring Lecture 5 IC interconnect model order reduction Zhuo Feng

EE5900 Spring Lecture 5 IC interconnect model order reduction Zhuo Feng EE59 Spring Parallel VLSI CAD Algorithms Lecture 5 IC interconnect model order reduction Zhuo Feng 5. Z. Feng MU EE59 In theory we can apply moment matching for any order of approximation But in practice

More information

SYMBOLIC ANALYSIS OF POWER/GROUND NETWORKS. focused on nding transfer function solutions for general

SYMBOLIC ANALYSIS OF POWER/GROUND NETWORKS. focused on nding transfer function solutions for general SYMBOLIC ANALYSIS OF POWER/GROUND NETWORKS USING MOMENT-MATCHING METHODS Jatan C Shah 1 Ahmed A Younis 1 Sachin S Sapatnekar 2 Marwan M Hassoun 1 1 Department of Electrical and Computer Engineering, Iowa

More information

Structure-Preserving Model Order Reduction of RCL Circuit Equations

Structure-Preserving Model Order Reduction of RCL Circuit Equations Structure-Preserving Model Order Reduction of RCL Circuit Equations Roland W. Freund Department of Mathematics, University of California at Davis, One Shields Avenue, Davis, CA 95616, U.S.A. freund@math.ucdavis.edu

More information

An Algorithm for Numerical Reference Generation in Symbolic Analysis of Large Analog Circuits

An Algorithm for Numerical Reference Generation in Symbolic Analysis of Large Analog Circuits An Algorithm for Numerical Reference Generation in Symbolic Analysis of Large Analog Circuits Ignacio García-Vargas, Mariano Galán, Francisco V. Fernández and Angel Rodríguez-Vázquez IMSE, Centro Nacional

More information

Wideband Modeling of RF/Analog Circuits via Hierarchical Multi-Point Model Order Reduction

Wideband Modeling of RF/Analog Circuits via Hierarchical Multi-Point Model Order Reduction 2E-1 Wideband Modeling of RF/Analog Circuits via Hierarchical Multi-Point Model Order Reduction Zhenyu Qi, Sheldon X.-D. Tan Department of Electrical Engineering, University of California, Riverside, CA

More information

Computing Phase Noise Eigenfunctions Directly from Steady-State Jacobian Matrices

Computing Phase Noise Eigenfunctions Directly from Steady-State Jacobian Matrices Computing Phase Noise Eigenfunctions Directly from Steady-State Jacobian Matrices Alper Demir David Long Jaijeet Roychowdhury Bell Laboratories Murray Hill New Jersey USA Abstract The main effort in oscillator

More information

An Optimum Fitting Algorithm for Generation of Reduced-Order Models

An Optimum Fitting Algorithm for Generation of Reduced-Order Models An Optimum Fitting Algorithm for Generation of Reduced-Order Models M.M. Gourary 1, S.G. Rusakov 1, S.L. Ulyanov 1, M.M. Zharov 1, B.J. Mulvaney 2 1 IPPM, Russian Academy of Sciences, Moscow 1523, e-mail:

More information

Laguerre-SVD Reduced-Order Modeling

Laguerre-SVD Reduced-Order Modeling IEEE TRANSACTIONS ON MICROWAVE THEORY AND TECHNIQUES, VOL. 48, NO. 9, SEPTEMBER 2000 1469 Laguerre-SVD Reduced-Order Modeling Luc Knockaert, Member, IEEE, and Daniël De Zutter, Senior Member, IEEE Abstract

More information

MODEL ORDER REDUCTION FOR PEEC MODELING BASED ON MOMENT MATCHING

MODEL ORDER REDUCTION FOR PEEC MODELING BASED ON MOMENT MATCHING Progress In Electromagnetics Research, Vol. 114, 285 299, 2011 MODEL ORDER REDUCTION FOR PEEC MODELING BASED ON MOMENT MATCHING Z. F. Song and D. L. Su EMC Laboratory, Beihang University 37 XueYuan Road,

More information

Asymptotic Waveform Evaluation(AWE) Technique for Frequency Domain Electromagnetic Analysis

Asymptotic Waveform Evaluation(AWE) Technique for Frequency Domain Electromagnetic Analysis NASA Technical Memorandum 110292 Asymptotic Waveform Evaluation(AWE Technique for Frequency Domain Electromagnetic Analysis C. R. Cockrell and F.B. Beck NASA Langley Research Center, Hampton, Virginia

More information

A Circuit Reduction Technique for Finding the Steady-State Solution of Nonlinear Circuits

A Circuit Reduction Technique for Finding the Steady-State Solution of Nonlinear Circuits IEEE TRANSACTIONS ON MICROWAVE THEORY AND TECHNIQUES, VOL. 48, NO. 12, DECEMBER 2000 2389 A Circuit Reduction Technique for Finding the Steady-State Solution of Nonlinear Circuits Emad Gad, Student Member,

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 7, 1998, pp. 1-17. Copyright 1998,. ISSN 1068-9613. ETNA ERROR ESTIMATION OF THE PADÉ APPROXIMATION OF TRANSFER FUNCTIONS VIA THE LANCZOS PROCESS ZHAOJUN

More information

Krylov-subspace methods for reduced-order modeling in circuit simulation

Krylov-subspace methods for reduced-order modeling in circuit simulation Krylov-subspace methods for reduced-order modeling in circuit simulation Roland Freund To cite this version: Roland Freund. Krylov-subspace methods for reduced-order modeling in circuit simulation. Journal

More information

Model-Order Reduction of High-Speed Interconnects: Challenges and Opportunities

Model-Order Reduction of High-Speed Interconnects: Challenges and Opportunities Model-Order Reduction of High-Speed Interconnects: Challenges and Opportunities Michel Nakhla Carleton University Canada Model Reduction for Complex Dynamical Systems Berlin 2010 EMI Delay Crosstalk Reflection

More information

T tional circuit simulators [5], is to obtain symbolic

T tional circuit simulators [5], is to obtain symbolic AWEsymbolic: Compiled Analysis of Linear(ized) Circuits using Asymptotic Waveform Evaluation John Y. Lee and Ronald A. Rohrer SRC-CMU Center for Computer Aided Design Department of Electrical and Computer

More information

Accurate Modeling of Lossy Nonuniform Transmission Lines by Using Differential Quadrature Methods

Accurate Modeling of Lossy Nonuniform Transmission Lines by Using Differential Quadrature Methods IEEE TRANSACTIONS ON MICROWAVE THEORY AND TECHNIQUES, VOL 50, NO 10, OCTOBER 2002 2233 Accurate Modeling of Lossy Nonuniform Transmission Lines by Using Differential Quadrature Methods Qinwei Xu, Student

More information

Rational ABCD Modeling of High-Speed Interconnects

Rational ABCD Modeling of High-Speed Interconnects Rational ABCD Modeling of High-Speed Interconnects Qinwei u and Pinaki Mazumder EECS Dept. University of Michigan, Ann Arbor, MI 4819 Email: qwxu@eecs.umich.edu, mazum@eecs.umich.edu Abstract This paper

More information

A partial Padé-via-Lanczos method for reduced-order modeling

A partial Padé-via-Lanczos method for reduced-order modeling Linear Algebra and its Applications 332 334 (2001) 139 164 www.elsevier.com/locate/laa A partial Padé-via-Lanczos method for reduced-order modeling Zhaojun Bai a,1, Roland W. Freund b, a Department of

More information

Peter Deuhard. for Symmetric Indenite Linear Systems

Peter Deuhard. for Symmetric Indenite Linear Systems Peter Deuhard A Study of Lanczos{Type Iterations for Symmetric Indenite Linear Systems Preprint SC 93{6 (March 993) Contents 0. Introduction. Basic Recursive Structure 2. Algorithm Design Principles 7

More information

VERIFYING systems hierarchically at different levels

VERIFYING systems hierarchically at different levels IEEE TRANSACTIONS ON CIRCUITS AND SYSTEMS II: ANALOG AND DIGITAL SIGNAL PROCESSING, VOL 46, NO 10, OCTOBER 1999 1273 Reduced-Order Modeling of Time-Varying Systems Jaijeet Roychowdhury Abstract We present

More information

J.TAUSCH AND J.WHITE 1. Capacitance Extraction of 3-D Conductor Systems in. Dielectric Media with high Permittivity Ratios

J.TAUSCH AND J.WHITE 1. Capacitance Extraction of 3-D Conductor Systems in. Dielectric Media with high Permittivity Ratios JTAUSCH AND JWHITE Capacitance Extraction of -D Conductor Systems in Dielectric Media with high Permittivity Ratios Johannes Tausch and Jacob White Abstract The recent development of fast algorithms for

More information

Analytical Delay Models for VLSI Interconnects Under Ramp Input

Analytical Delay Models for VLSI Interconnects Under Ramp Input Analytical Delay Models for VLSI Interconnects Under amp Input Andrew B. Kahng, Kei Masuko, and Sudhakar Muddu UCLA Computer Science Department, Los Angeles, CA 995-596 USA Cadence Design Systems, Inc.,

More information

Positive Denite Matrix. Ya Yan Lu 1. Department of Mathematics. City University of Hong Kong. Kowloon, Hong Kong. Abstract

Positive Denite Matrix. Ya Yan Lu 1. Department of Mathematics. City University of Hong Kong. Kowloon, Hong Kong. Abstract Computing the Logarithm of a Symmetric Positive Denite Matrix Ya Yan Lu Department of Mathematics City University of Hong Kong Kowloon, Hong Kong Abstract A numerical method for computing the logarithm

More information

Fast Simulation of VLSI Interconnects

Fast Simulation of VLSI Interconnects Fast Simulation of VLSI Interconnects Jitesh Jain, Cheng-Kok Koh, and Venkataramanan Balakrishnan School of Electrical and Computer Engineering Purdue University, West Lafayette, IN 4797-1285 {jjain,chengkok,ragu}@ecn.purdue.edu

More information

Institute for Advanced Computer Studies. Department of Computer Science. Iterative methods for solving Ax = b. GMRES/FOM versus QMR/BiCG

Institute for Advanced Computer Studies. Department of Computer Science. Iterative methods for solving Ax = b. GMRES/FOM versus QMR/BiCG University of Maryland Institute for Advanced Computer Studies Department of Computer Science College Park TR{96{2 TR{3587 Iterative methods for solving Ax = b GMRES/FOM versus QMR/BiCG Jane K. Cullum

More information

Passive Interconnect Macromodeling Via Balanced Truncation of Linear Systems in Descriptor Form

Passive Interconnect Macromodeling Via Balanced Truncation of Linear Systems in Descriptor Form Passive Interconnect Macromodeling Via Balanced Truncation of Linear Systems in Descriptor Form Boyuan Yan, Sheldon X.-D. Tan,PuLiu and Bruce McGaughy Department of Electrical Engineering, University of

More information

Efficient Incremental Analysis of On-Chip Power Grid via Sparse Approximation

Efficient Incremental Analysis of On-Chip Power Grid via Sparse Approximation Efficient Incremental Analysis of On-Chip Power Grid via Sparse Approximation Pei Sun and Xin Li ECE Department, Carnegie Mellon University 5000 Forbes Avenue, Pittsburgh, PA 1513 {peis, xinli}@ece.cmu.edu

More information

AN INDEPENDENT LOOPS SEARCH ALGORITHM FOR SOLVING INDUCTIVE PEEC LARGE PROBLEMS

AN INDEPENDENT LOOPS SEARCH ALGORITHM FOR SOLVING INDUCTIVE PEEC LARGE PROBLEMS Progress In Electromagnetics Research M, Vol. 23, 53 63, 2012 AN INDEPENDENT LOOPS SEARCH ALGORITHM FOR SOLVING INDUCTIVE PEEC LARGE PROBLEMS T.-S. Nguyen *, J.-M. Guichon, O. Chadebec, G. Meunier, and

More information

Parallel VLSI CAD Algorithms. Lecture 1 Introduction Zhuo Feng

Parallel VLSI CAD Algorithms. Lecture 1 Introduction Zhuo Feng Parallel VLSI CAD Algorithms Lecture 1 Introduction Zhuo Feng 1.1 Prof. Zhuo Feng Office: EERC 513 Phone: 487-3116 Email: zhuofeng@mtu.edu Class Website http://www.ece.mtu.edu/~zhuofeng/ee5900spring2012.html

More information

MODEL-order reduction is emerging as an effective

MODEL-order reduction is emerging as an effective IEEE TRANSACTIONS ON CIRCUITS AND SYSTEMS I: REGULAR PAPERS, VOL. 52, NO. 5, MAY 2005 975 Model-Order Reduction by Dominant Subspace Projection: Error Bound, Subspace Computation, and Circuit Applications

More information

Compact Distributed RLC Interconnect Models Part I: Single Line Transient, Time Delay, and Overshoot Expressions

Compact Distributed RLC Interconnect Models Part I: Single Line Transient, Time Delay, and Overshoot Expressions 2068 IEEE TRANSACTIONS ON ELECTRON DEVICES, VOL. 47, NO. 11, NOVEMBER 2000 Compact Distributed RLC Interconnect Models Part I: Single Line Transient, Time Delay, and Overshoot Expressions Jeffrey A. Davis

More information

The restarted QR-algorithm for eigenvalue computation of structured matrices

The restarted QR-algorithm for eigenvalue computation of structured matrices Journal of Computational and Applied Mathematics 149 (2002) 415 422 www.elsevier.com/locate/cam The restarted QR-algorithm for eigenvalue computation of structured matrices Daniela Calvetti a; 1, Sun-Mi

More information

L. Miguel Silveira Ibrahim M. Elfadel Jacob K. White. 555 River Oaks Parkway, MS 3B1. tables of data.

L. Miguel Silveira Ibrahim M. Elfadel Jacob K. White. 555 River Oaks Parkway, MS 3B1. tables of data. An Ecient Approach to Transmission Line Simulation using Measured or Tabulated S-parameter Data L. Miguel Silveira Ibrahim M. Elfadel Jacob K. White Research Laboratory of Electronics and the Department

More information

ERIK STERNER. Discretize the equations in space utilizing a nite volume or nite dierence scheme. 3. Integrate the corresponding time-dependent problem

ERIK STERNER. Discretize the equations in space utilizing a nite volume or nite dierence scheme. 3. Integrate the corresponding time-dependent problem Convergence Acceleration for the Navier{Stokes Equations Using Optimal Semicirculant Approximations Sverker Holmgren y, Henrik Branden y and Erik Sterner y Abstract. The iterative solution of systems of

More information

Efficient Simulation of Lossy and Dispersive Transmission Lines

Efficient Simulation of Lossy and Dispersive Transmission Lines Efficient Simulation of Lossy and Dispersive Transmission Lines Tuyen V. guyen* IBM Microelectronics, Hopewell Junction, Y 2533 Abstract - This paper presents an efficient method, based on the transfer

More information

Model Order Reduction for Systems with Non-Rational Transfer Function Arising in Computational Electromagnetics

Model Order Reduction for Systems with Non-Rational Transfer Function Arising in Computational Electromagnetics Model Order Reduction for Systems with Non-Rational Transfer Function Arising in Computational Electromagnetics Lihong Feng and Peter Benner Abstract We consider model order reduction of a system described

More information

An Equivalent Circuit Formulation of the Power Flow Problem with Current and Voltage State Variables

An Equivalent Circuit Formulation of the Power Flow Problem with Current and Voltage State Variables An Equivalent Circuit Formulation of the Power Flow Problem with Current and Voltage State Variables David M. Bromberg, Marko Jereminov, Xin Li, Gabriela Hug, Larry Pileggi Dept. of Electrical and Computer

More information

An efficient DC-gain matched balanced truncation realization for VLSI interconnect circuit order reduction

An efficient DC-gain matched balanced truncation realization for VLSI interconnect circuit order reduction Microelectronic Engineering 60 (00) 15 www.elsevier.com/ locate/ mee An efficient DC-gain matched balanced truncation realization for VLSI interconnect circuit order reduction Xuan Zeng *, Dian Zhou, Wei

More information

Model Order-Reduction of RC(L) Interconnect including Variational Analysis

Model Order-Reduction of RC(L) Interconnect including Variational Analysis _ Model Order-Reduction of RC(L) Interconnect including Variational Analysis Ying Liu, Lawrence T. Pileggi and Andrzej J. Strojwas Department of Electrical and Computer Engineering Carnegie Mellon University

More information

Introduction. HFSS 3D EM Analysis S-parameter. Q3D R/L/C/G Extraction Model. magnitude [db] Frequency [GHz] S11 S21 -30

Introduction. HFSS 3D EM Analysis S-parameter. Q3D R/L/C/G Extraction Model. magnitude [db] Frequency [GHz] S11 S21 -30 ANSOFT Q3D TRANING Introduction HFSS 3D EM Analysis S-parameter Q3D R/L/C/G Extraction Model 0-5 -10 magnitude [db] -15-20 -25-30 S11 S21-35 0 1 2 3 4 5 6 7 8 9 10 Frequency [GHz] Quasi-static or full-wave

More information

Direct Conversions Between DV Format DCT and Ordinary DCT

Direct Conversions Between DV Format DCT and Ordinary DCT Direct Conversions Between DV Format DCT Ordinary DCT Neri Merhav HP Laboratories Israel* HPL-9-4 August, 99 digital recording, DVC format, - DCT, 2-4- DCT A fast algorithm is developed for direct conversions

More information

Implementation of a Transmission Line Model with the PEEC Method for Lightning Surge Analysis

Implementation of a Transmission Line Model with the PEEC Method for Lightning Surge Analysis Implementation of a Transmission Line Model with the PEEC Method for Lightning Surge Analysis PEERAWUT YUTTHAGOWITH Department of Electrical Engineering, Faculty of Engineering King Mongkut s Institute

More information

Automatic Generation of Geometrically Parameterized Reduced Order Models for Integrated Spiral RF-Inductors

Automatic Generation of Geometrically Parameterized Reduced Order Models for Integrated Spiral RF-Inductors Automatic Generation of Geometrically Parameterized Reduced Order Models for Integrated Spiral RF-Inductors Luca Daniel Massachusetts Institute of Technology Dept. of Elect. Engin. and Comp. Science Research

More information

on a Stochastic Current Waveform Urbana, Illinois Dallas, Texas Abstract

on a Stochastic Current Waveform Urbana, Illinois Dallas, Texas Abstract Electromigration Median Time-to-Failure based on a Stochastic Current Waveform by Farid Najm y, Ibrahim Hajj y, and Ping Yang z y Coordinated Science Laboratory z VLSI Design Laboratory University of Illinois

More information

Relative Irradiance. Wavelength (nm)

Relative Irradiance. Wavelength (nm) Characterization of Scanner Sensitivity Gaurav Sharma H. J. Trussell Electrical & Computer Engineering Dept. North Carolina State University, Raleigh, NC 7695-79 Abstract Color scanners are becoming quite

More information

DTT: Direct Truncation of the Transfer Function An Alternative to Moment Matching for Tree Structured Interconnect

DTT: Direct Truncation of the Transfer Function An Alternative to Moment Matching for Tree Structured Interconnect IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 21, NO. 2, FEBRUARY 2002 131 DTT: Direct Truncation of the Transfer Function An Alternative to Moment Matching for Tree

More information

Advanced Computational Methods for VLSI Systems. Lecture 4 RF Circuit Simulation Methods. Zhuo Feng

Advanced Computational Methods for VLSI Systems. Lecture 4 RF Circuit Simulation Methods. Zhuo Feng Advanced Computational Methods for VLSI Systems Lecture 4 RF Circuit Simulation Methods Zhuo Feng 6. Z. Feng MTU EE59 Neither ac analysis nor pole / zero analysis allow nonlinearities Harmonic balance

More information

Key words. conjugate gradients, normwise backward error, incremental norm estimation.

Key words. conjugate gradients, normwise backward error, incremental norm estimation. Proceedings of ALGORITMY 2016 pp. 323 332 ON ERROR ESTIMATION IN THE CONJUGATE GRADIENT METHOD: NORMWISE BACKWARD ERROR PETR TICHÝ Abstract. Using an idea of Duff and Vömel [BIT, 42 (2002), pp. 300 322

More information

A New Simulation Technique for Periodic Small-Signal Analysis

A New Simulation Technique for Periodic Small-Signal Analysis A New Simulation Technique for Periodic Small-Signal Analysis MM.Gourary,S.G.Rusakov,S.L.Ulyanov,M.M.Zharov IPPM, Russian Academy of Sciences, Moscow, Russia B. J. Mulvaney Motorola Inc., Austin, Texas,

More information

Cyclic Reduction History and Applications

Cyclic Reduction History and Applications ETH Zurich and Stanford University Abstract. We discuss the method of Cyclic Reduction for solving special systems of linear equations that arise when discretizing partial differential equations. In connection

More information

Sensitivity Analysis of Coupled Resonator Filters

Sensitivity Analysis of Coupled Resonator Filters IEEE TRANSACTIONS ON CIRCUITS AND SYSTEMS II: ANALOG AND DIGITAL SIGNAL PROCESSING, VOL. 47, NO. 10, OCTOBER 2000 1017 Sensitivity Analysis of Coupled Resonator Filters Smain Amari, Member, IEEE Abstract

More information

Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012

Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012 Instructions Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012 The exam consists of four problems, each having multiple parts. You should attempt to solve all four problems. 1.

More information

Math 405: Numerical Methods for Differential Equations 2016 W1 Topics 10: Matrix Eigenvalues and the Symmetric QR Algorithm

Math 405: Numerical Methods for Differential Equations 2016 W1 Topics 10: Matrix Eigenvalues and the Symmetric QR Algorithm Math 405: Numerical Methods for Differential Equations 2016 W1 Topics 10: Matrix Eigenvalues and the Symmetric QR Algorithm References: Trefethen & Bau textbook Eigenvalue problem: given a matrix A, find

More information

Fast On-Chip Inductance Simulation Using a Precorrected-FFT Method

Fast On-Chip Inductance Simulation Using a Precorrected-FFT Method IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 22, NO. 1, JANUARY 2003 49 Fast On-Chip Inductance Simulation Using a Precorrected-FFT Method Haitian Hu, Member, IEEE,

More information

SYSTEM RECONSTRUCTION FROM SELECTED HOS REGIONS. Haralambos Pozidis and Athina P. Petropulu. Drexel University, Philadelphia, PA 19104

SYSTEM RECONSTRUCTION FROM SELECTED HOS REGIONS. Haralambos Pozidis and Athina P. Petropulu. Drexel University, Philadelphia, PA 19104 SYSTEM RECOSTRUCTIO FROM SELECTED HOS REGIOS Haralambos Pozidis and Athina P. Petropulu Electrical and Computer Engineering Department Drexel University, Philadelphia, PA 94 Tel. (25) 895-2358 Fax. (25)

More information

Electromagnetic Modeling and Signal Integrity Simulation of Power/Ground Networks in High Speed Digital Packages and Printed Circuit Boards

Electromagnetic Modeling and Signal Integrity Simulation of Power/Ground Networks in High Speed Digital Packages and Printed Circuit Boards Electromagnetic Modeling and Signal Integrity Simulation of Power/Ground Networks in High Speed Digital Packages and Printed Circuit Boards Frank Y. Yuan Viewlogic Systems Group, Inc. 385 Del Norte Road

More information

The Lanczos and conjugate gradient algorithms

The Lanczos and conjugate gradient algorithms The Lanczos and conjugate gradient algorithms Gérard MEURANT October, 2008 1 The Lanczos algorithm 2 The Lanczos algorithm in finite precision 3 The nonsymmetric Lanczos algorithm 4 The Golub Kahan bidiagonalization

More information

A Trajectory Piecewise-Linear Approach to Model Order Reduction and Fast Simulation of Nonlinear Circuits and Micromachined Devices

A Trajectory Piecewise-Linear Approach to Model Order Reduction and Fast Simulation of Nonlinear Circuits and Micromachined Devices A Trajectory Piecewise-Linear Approach to Model Order Reduction and Fast Simulation of Nonlinear Circuits and Micromachined Devices Michał Rewieński, Jacob White Department of Electrical Engineering and

More information

Last Time. Social Network Graphs Betweenness. Graph Laplacian. Girvan-Newman Algorithm. Spectral Bisection

Last Time. Social Network Graphs Betweenness. Graph Laplacian. Girvan-Newman Algorithm. Spectral Bisection Eigenvalue Problems Last Time Social Network Graphs Betweenness Girvan-Newman Algorithm Graph Laplacian Spectral Bisection λ 2, w 2 Today Small deviation into eigenvalue problems Formulation Standard eigenvalue

More information

Parallel-Distributed Time-Domain Circuit Simulation of Power Distribution Networks with Frequency-Dependent Parameters

Parallel-Distributed Time-Domain Circuit Simulation of Power Distribution Networks with Frequency-Dependent Parameters Parallel-Distributed Time-Domain Circuit Simulation of Power Distribution Networks with Frequency-Dependent Parameters Takayuki WATANABE Yuichi TANJI Hidemasa KUBOTA Hideki ASAI School of Administration

More information

IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 34, NO. 3, MARCH

IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 34, NO. 3, MARCH IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 34, NO. 3, MARCH 2015 409 Efficient Transient Analysis of Power Delivery Network With Clock/Power Gating by Sparse Approximation

More information

Theory and Problems of Signals and Systems

Theory and Problems of Signals and Systems SCHAUM'S OUTLINES OF Theory and Problems of Signals and Systems HWEI P. HSU is Professor of Electrical Engineering at Fairleigh Dickinson University. He received his B.S. from National Taiwan University

More information

A Sequential Quadratic Programming Approach to Concurrent Gate and Wire Sizing *

A Sequential Quadratic Programming Approach to Concurrent Gate and Wire Sizing * A Sequential Quadratic Programming Approach to Concurrent Gate and Wire Sizing * Noel Menezes, Ross Baldick, and Lawrence T. Pileggi Department of Electrical and Computer Engineering The University of

More information

Fast FDTD Simulation Using Laguerre Polynomials in MNA Framework

Fast FDTD Simulation Using Laguerre Polynomials in MNA Framework Fast FDTD Simulation Using Laguerre Polynomials in MNA Framework K. Srinivasan 1, E. Engin and M. Swaminathan 3 Georgia Institute of Technology School of Electrical and Computer Engineering 777 Atlantic

More information

Information Storage Capacity of Crossbar Switching Networks

Information Storage Capacity of Crossbar Switching Networks Information Storage Capacity of Crossbar Switching etworks ABSTRACT In this work we ask the fundamental uestion: How many bits of information can be stored in a crossbar switching network? The answer is

More information

Krylov Techniques for Model Reduction of Second-Order Systems

Krylov Techniques for Model Reduction of Second-Order Systems Krylov Techniques for Model Reduction of Second-Order Systems A Vandendorpe and P Van Dooren February 4, 2004 Abstract The purpose of this paper is to present a Krylov technique for model reduction of

More information

E8-262: Basics of Circuit Simulation/SPICE. Lecture: 4+5

E8-262: Basics of Circuit Simulation/SPICE. Lecture: 4+5 E8-262: Basics of Circuit Simulation/SPICE Lecture: 4+5 Module 1: Electrical Challenges in High-Speed CPS Types of packages and PCBs Packaging Trends Review of Electromagnetic and Circuit basics Signal

More information

Krylov subspace iterative methods for nonsymmetric discrete ill-posed problems in image restoration

Krylov subspace iterative methods for nonsymmetric discrete ill-posed problems in image restoration Krylov subspace iterative methods for nonsymmetric discrete ill-posed problems in image restoration D. Calvetti a, B. Lewis b and L. Reichel c a Department of Mathematics, Case Western Reserve University,

More information

Numerical Analysis: Solutions of System of. Linear Equation. Natasha S. Sharma, PhD

Numerical Analysis: Solutions of System of. Linear Equation. Natasha S. Sharma, PhD Mathematical Question we are interested in answering numerically How to solve the following linear system for x Ax = b? where A is an n n invertible matrix and b is vector of length n. Notation: x denote

More information

A Stable Finite Dierence Ansatz for Higher Order Dierentiation of Non-Exact. Data. Bob Anderssen and Frank de Hoog,

A Stable Finite Dierence Ansatz for Higher Order Dierentiation of Non-Exact. Data. Bob Anderssen and Frank de Hoog, A Stable Finite Dierence Ansatz for Higher Order Dierentiation of Non-Exact Data Bob Anderssen and Frank de Hoog, CSIRO Division of Mathematics and Statistics, GPO Box 1965, Canberra, ACT 2601, Australia

More information

AMS 147 Computational Methods and Applications Lecture 17 Copyright by Hongyun Wang, UCSC

AMS 147 Computational Methods and Applications Lecture 17 Copyright by Hongyun Wang, UCSC Lecture 17 Copyright by Hongyun Wang, UCSC Recap: Solving linear system A x = b Suppose we are given the decomposition, A = L U. We solve (LU) x = b in 2 steps: *) Solve L y = b using the forward substitution

More information

A Cholesky LR algorithm for the positive definite symmetric diagonal-plus-semiseparable eigenproblem

A Cholesky LR algorithm for the positive definite symmetric diagonal-plus-semiseparable eigenproblem A Cholesky LR algorithm for the positive definite symmetric diagonal-plus-semiseparable eigenproblem Bor Plestenjak Department of Mathematics University of Ljubljana Slovenia Ellen Van Camp and Marc Van

More information

Fractal Dimension and Vector Quantization

Fractal Dimension and Vector Quantization Fractal Dimension and Vector Quantization [Extended Abstract] Krishna Kumaraswamy Center for Automated Learning and Discovery, Carnegie Mellon University skkumar@cs.cmu.edu Vasileios Megalooikonomou Department

More information

Lecture 2: Computing functions of dense matrices

Lecture 2: Computing functions of dense matrices Lecture 2: Computing functions of dense matrices Paola Boito and Federico Poloni Università di Pisa Pisa - Hokkaido - Roma2 Summer School Pisa, August 27 - September 8, 2018 Introduction In this lecture

More information

Integer Least Squares: Sphere Decoding and the LLL Algorithm

Integer Least Squares: Sphere Decoding and the LLL Algorithm Integer Least Squares: Sphere Decoding and the LLL Algorithm Sanzheng Qiao Department of Computing and Software McMaster University 28 Main St. West Hamilton Ontario L8S 4L7 Canada. ABSTRACT This paper

More information

limit of the time-step decreases as more resolutions are added requires the use of an eective multitime-stepping algorithm, that will maintain the req

limit of the time-step decreases as more resolutions are added requires the use of an eective multitime-stepping algorithm, that will maintain the req Invited to the Session: "Wavelet and TLM Modeling Techniques" organized by Dr. W. J. R. Hoefer in ACES 2000 COMPUTATIONAL OPTIMIZATION OF MRTD HAAR-BASED ADAPTIVE SCHEMES USED FOR THE DESIGN OF RF PACKAGING

More information

Bit -Line. Bit -Line. 2.1 Concept. Local Word Line. Global Word Line. Sub Bit-Line. Figure 1. Divided Bit-Line Approach, M = Theoretical Basis

Bit -Line. Bit -Line. 2.1 Concept. Local Word Line. Global Word Line. Sub Bit-Line. Figure 1. Divided Bit-Line Approach, M = Theoretical Basis ow Power SRA Design using Hierarchical Divided Bit-ine Approach Ashish Karandikar y Intel orporation, Santa lara, A 95052, USA E-mail: akarand@td2cad.intel.com Keshab K. Parhi Dept. of Electrical and omputer

More information

Krylov subspace techniques for reduced-order modeling of large-scale dynamical systems

Krylov subspace techniques for reduced-order modeling of large-scale dynamical systems Applied Numerical Mathematics 43 (2002) 9 44 www.elsevier.com/locate/apnum Krylov subspace techniques for reduced-order modeling of large-scale dynamical systems Zhaojun Bai Department of Computer Science,

More information

immediately, without knowledge of the jobs that arrive later The jobs cannot be preempted, ie, once a job is scheduled (assigned to a machine), it can

immediately, without knowledge of the jobs that arrive later The jobs cannot be preempted, ie, once a job is scheduled (assigned to a machine), it can A Lower Bound for Randomized On-Line Multiprocessor Scheduling Jir Sgall Abstract We signicantly improve the previous lower bounds on the performance of randomized algorithms for on-line scheduling jobs

More information

Vector Potential Equivalent Circuit Based on PEEC Inversion

Vector Potential Equivalent Circuit Based on PEEC Inversion 43.2 Vector Potential Equivalent Circuit Based on PEEC Inversion Hao Yu EE Department, UCLA Los Angeles, CA 90095 Lei He EE Department, UCLA Los Angeles, CA 90095 ABSTRACT The geometry-integration based

More information

Model reduction of large-scale dynamical systems

Model reduction of large-scale dynamical systems Model reduction of large-scale dynamical systems Lecture III: Krylov approximation and rational interpolation Thanos Antoulas Rice University and Jacobs University email: aca@rice.edu URL: www.ece.rice.edu/

More information

Automatica, 33(9): , September 1997.

Automatica, 33(9): , September 1997. A Parallel Algorithm for Principal nth Roots of Matrices C. K. Koc and M. _ Inceoglu Abstract An iterative algorithm for computing the principal nth root of a positive denite matrix is presented. The algorithm

More information

ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH

ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH V. FABER, J. LIESEN, AND P. TICHÝ Abstract. Numerous algorithms in numerical linear algebra are based on the reduction of a given matrix

More information

35 th Design Automation Conference Copyright 1998 ACM

35 th Design Automation Conference Copyright 1998 ACM Ecient Three-Dimensional Extraction Based on Static and Full-Wave Layered Green's Functions Jinsong Zhao Wayne W.M. Dai Department of Computer Engineering UC Santa Cruz Santa Cruz, CA 9564 Sharad Kapur

More information

MATH 5640: Functions of Diagonalizable Matrices

MATH 5640: Functions of Diagonalizable Matrices MATH 5640: Functions of Diagonalizable Matrices Hung Phan, UMass Lowell November 27, 208 Spectral theorem for diagonalizable matrices Definition Let V = X Y Every v V is uniquely decomposed as u = x +

More information

Identification of Electrical Circuits for Realization of Sparsity Preserving Reduced Order Models

Identification of Electrical Circuits for Realization of Sparsity Preserving Reduced Order Models Identification of Electrical Circuits for Realization of Sparsity Preserving Reduced Order Models Christof Kaufmann 25th March 2010 Abstract Nowadays very-large scale integrated circuits contain a large

More information

CONTINUOUS TIME D=0 ZOH D 0 D=0 FOH D 0

CONTINUOUS TIME D=0 ZOH D 0 D=0 FOH D 0 IDENTIFICATION ASPECTS OF INTER- SAMPLE INPUT BEHAVIOR T. ANDERSSON, P. PUCAR and L. LJUNG University of Linkoping, Department of Electrical Engineering, S-581 83 Linkoping, Sweden Abstract. In this contribution

More information

Today s class. Linear Algebraic Equations LU Decomposition. Numerical Methods, Fall 2011 Lecture 8. Prof. Jinbo Bi CSE, UConn

Today s class. Linear Algebraic Equations LU Decomposition. Numerical Methods, Fall 2011 Lecture 8. Prof. Jinbo Bi CSE, UConn Today s class Linear Algebraic Equations LU Decomposition 1 Linear Algebraic Equations Gaussian Elimination works well for solving linear systems of the form: AX = B What if you have to solve the linear

More information

Chap 4. State-Space Solutions and

Chap 4. State-Space Solutions and Chap 4. State-Space Solutions and Realizations Outlines 1. Introduction 2. Solution of LTI State Equation 3. Equivalent State Equations 4. Realizations 5. Solution of Linear Time-Varying (LTV) Equations

More information

Figure Circuit for Question 1. Figure Circuit for Question 2

Figure Circuit for Question 1. Figure Circuit for Question 2 Exercises 10.7 Exercises Multiple Choice 1. For the circuit of Figure 10.44 the time constant is A. 0.5 ms 71.43 µs 2, 000 s D. 0.2 ms 4 Ω 2 Ω 12 Ω 1 mh 12u 0 () t V Figure 10.44. Circuit for Question

More information

RECURSIVE CONVOLUTION ALGORITHMS FOR TIME-DOMAIN SIMULATION OF ELECTRONIC CIRCUITS

RECURSIVE CONVOLUTION ALGORITHMS FOR TIME-DOMAIN SIMULATION OF ELECTRONIC CIRCUITS COMPUTATIONAL METHODS IN SCIENCE AND TECHNOLOGY 7(2), 91-109 (2001) RECURSIVE CONVOLUTION ALGORITHMS FOR TIME-DOMAIN SIMULATION OF ELECTRONIC CIRCUITS GRZEGORZ BLAKIEWICZ 1 AND WŁODZIMIERZ JANKE 2 1 Techn.

More information

Efficient Partial Element Calculation and the Extension to Cylindrical Elements for the PEEC Method

Efficient Partial Element Calculation and the Extension to Cylindrical Elements for the PEEC Method Efficient Partial Element Calculation and the Extension to Cylindrical Elements for the PEEC Method A. Müsing and J. W. Kolar Power Electronic Systems Laboratory, ETH Zürich CH-8092 Zürich, Switzerland

More information

NEW APPROACH TO THE RATIONAL INTERPOLATION PROBLEM

NEW APPROACH TO THE RATIONAL INTERPOLATION PROBLEM Luminy paper - 1990 1 NEW APPROACH TO THE RATIONAL INTERPOLATION PROBLEM Marc Van Barel, A. Bultheel Abstract We shall reformulate the classical Newton-Padé rational interpolation problem (NPRIP) to take

More information

Stability of implicit extrapolation methods. Abstract. Multilevel methods are generally based on a splitting of the solution

Stability of implicit extrapolation methods. Abstract. Multilevel methods are generally based on a splitting of the solution Contemporary Mathematics Volume 00, 0000 Stability of implicit extrapolation methods Abstract. Multilevel methods are generally based on a splitting of the solution space associated with a nested sequence

More information

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation Tao Zhao 1, Feng-Nan Hwang 2 and Xiao-Chuan Cai 3 Abstract In this paper, we develop an overlapping domain decomposition

More information

OPTIMAL SCALING FOR P -NORMS AND COMPONENTWISE DISTANCE TO SINGULARITY

OPTIMAL SCALING FOR P -NORMS AND COMPONENTWISE DISTANCE TO SINGULARITY published in IMA Journal of Numerical Analysis (IMAJNA), Vol. 23, 1-9, 23. OPTIMAL SCALING FOR P -NORMS AND COMPONENTWISE DISTANCE TO SINGULARITY SIEGFRIED M. RUMP Abstract. In this note we give lower

More information

INTEGRATION OF INTERCONNECT MODELS IN A CIRCUIT SIMULATOR

INTEGRATION OF INTERCONNECT MODELS IN A CIRCUIT SIMULATOR INTEGRATION OF INTERCONNECT MODELS IN A CIRCUIT SIMULATOR by RAMYA MOHAN A thesis submitted to the Graduate Faculty of North Carolina State University in partial fulfillment of the requirements for the

More information