An H-LU Based Direct Finite Element Solver Accelerated by Nested Dissection for Large-scale Modeling of ICs and Packages

Size: px
Start display at page:

Download "An H-LU Based Direct Finite Element Solver Accelerated by Nested Dissection for Large-scale Modeling of ICs and Packages"

Transcription

1 PIERS ONLINE, VOL. 6, NO. 7, An H-LU Based Direct Finite Element Solver Accelerated by Nested Dissection for Large-scale Modeling of ICs and Packages Haixin Liu and Dan Jiao School of Electrical and Computer Engineering, Purdue University 465 Northwestern Avenue, West Lafayette, IN 47907, USA Abstract In this work, we prove that for the sparse matrix resulting from a finite-elementbased analysis of electrodynamic problems, its inverse has a data-sparse H-matrix approximation with error well controlled. Based on this proof, we develop a fast direct finite element solver. In this direct solver, the H-matrix-based LU factorization is developed, which is further accelerated by nested dissection. We show that the proposed direct solver has an O(kN logn) memory complexity and O(k 2 Nlog 2 N) time complexity, where k is a small number that is adaptively determined based on accuracy requirements, and N is the number of. A comparison with the state-of-the-art direct finite element solver that employs the most advanced sparse matrix solution has shown a clear advantage of the proposed solver. Applications to large-scale package modeling involving millions of have demonstrated the accuracy and almost linear complexity of the proposed direct solver. In addition, the proposed method is applicable to arbitrarily-shaped three-dimensional structures and arbitrary inhomogeneity. 1. INTRODUCTION A finite element method (FEM) based analysis of a large-scale IC and package problem generally results in a large-scale system matrix. Although the matrix is sparse, solving it can be a computational challenge when the problem size is large. There exists a general mathematical framework called the Hierarchical (H) Matrix framework [1 4], which enables a highly compact representation and efficient numerical computation of the dense matrices. It has been shown that the storage requirements and matrix-vector multiplications using H matrices are of complexity O(N logn), and the inverse of an H-matrix can be obtained in O(Nlog 2 N) complexity. In [5, 6], we developed an H-matrix based solver to efficiently compute and store the inverse of a finite element matrix. In this work, we develop an LU-factorization based fast finite-element solver. We then further accelerate the H-based LU solver by Nested Dissection [7]. The main contribution of this work is four-fold. First, we theoretically prove the existence of an H-matrix-based representation of the FEM matrix and its inverse for electrodynamic problems. The existence of an H-matrix approximation so far was only proved for elliptic partial differential equations (PDE) [8], whereas the Maxwell s equations are hyperbolic in nature. Second, we develop an H-matrix-based LU solver of O(kN logn) memory complexity and O(k 2 Nlog 2 N) time complexity for solving vector wave equations, where k is a variable that is adaptively determined based on the accuracy requirement, which is also small compared to N. The H-based LU is further accelerated by Nested Dissection [7]. Third, we develop a theoretical analysis of the complexity and accuracy for the proposed fast direct solver. In addition, we compare the proposed direct solver with the state-of-the-art direct sparse solver such as 5.0 [9]. has incorporated almost all the advanced sparse matrix techniques such as the multifrontal method and the approximate minimum degree (AMD) ordering for solving large-scale sparse matrices. The proposed solver is shown to outperform the 5.0 in both matrix decomposition and matrix solution time without sacrificing accuracy. 2. ON THE EXISTENCE OF H-MATRIX REPRESENTATION OF THE FEM MATRIX AND ITS INVERSE FOR ELECTRODYNAMIC PROBLEMS It has been proven in the mathematical literature that the FEM matrix resulting from the analysis of elliptic partial differential equations such as a Poisson equation has an H-matrix representation. Moreover, its inverse also allows for a date-sparse H-matrix approximation [8]. However, the full Maxwell s equations are hyperbolic partial differential equations in nature. Therefore, the proof developed for elliptic PDE-based equations does not apply to the wave equation, which governs all the electrodynamic phenomena. The existence of an H-matrix representation of the FEM system

2 PIERS ONLINE, VOL. 6, NO. 7, matrix for electrodynamic analysis is obvious based on the definition of an H-matrix [1 4]. In the following, we rigorously prove that the inverse of the FEM matrix also allows for an H-matrix representation. Consider the electric field E due to an arbitrary current distribution J in free space. The current distribution J can always be decomposed into a group of electric dipoles Ĩil i, where Ĩi is the current of the i-th element and l i is the length of the i-th current element. An FEM-based solution to the second-order vector wave equation subject to boundary conditions results in a linear system of equations Y{E} = {I} (1) where the right-hand-side vector {I} has the following entries I i = jωµ 0 Ĩ i l i. (2) On the other hand, E due to any current distribution J can be evaluated from the following integral ( E = jωµ 0 JG ) V k0 2 J G 0 dv (3) where G 0 is the free-space Green s function. For a group of electric dipoles Ĩil i, the E field radiated by them at any point in the computational domain can be written as {E} = Z{I} (4) where {I} vector is the same as that in (1), Z is a dense matrix having the following elements { 1 Z mn = jωµ 0ˆt m (r m ) jωµ ˆl n (r n)g 0 (r m, r n) j 0 ωε ˆt [ m (r m ) (ˆl n (r )G 0 (r, r ))] } (5) and {E} vector has the following entries E m = ˆt m (r m ) E(r m ) (6) where ˆt m is the unit vector tangential to the m-th edge, ˆl n is the unit vector tangential to the n-th current element, r m denotes the center point of the m-th edge, r n denotes the point where the n-th current element is located. Comparing (1) to (4), it is clear that the inverse of the FEM matrix Y is Z. Since we have proved in [10 12] that the Z resulting from an integral-equation based analysis can be represented by an H-matrix with error well controlled, we prove that Y s inverse has an H-matrix representation. Following a proof similar to the above, we can show that the inverse of the FEM matrix in a non-uniform material can also be represented by an H-matrix. 3. PROPOSED FAST DIRECT FEM SOLVER In [5, 6], we developed an H-inverse based fast direct FEM solver. Since what is to be solved in (1) is Y 1 {I} instead of Y 1, an LU-factorization-based direct solution is generally more efficient than an inverse-based direct solution. In addition, in the LU factorization, the input matrix can be overwritten by L and U factors, thus the memory usage can be saved by half. The proposed LU-based direct solution has three components: (1) H-based recursive LU factorization; (2) matrix solution by H-based backward and forward substitution; and (3) acceleration by nested dissection Recursive LU Factorization and Matrix Solution We use an H-matrix block Y tt to demonstrate the H-LU factorization process, where t is a non-leaf cluster in the cluster tree T I [5, 6]. If t is a non-leaf, block t t is not a leaf block and hence Y tt can be subdivided into four sub blocks: ( ) Yt1t Y tt = 1 Y t1t 2 (7) Y t2t 1 Y t2t 2 where t 1 and t 2 are the children of t in the cluster tree T I.

3 PIERS ONLINE, VOL. 6, NO. 7, Assuming Y can be factorized into L and U matrices, Y can also be written as: ( ) ( ) ( ) Lt1t Y tt = L tt U tt = 1 0 Ut1t 1 U t1t 2 Lt1t = 1 U t1t 1 L t1t 1 U t1t 2 L t2t 2 0 U t2t 2 U t1t 1 U t1t 2 + L t2t 2 U t2t 2 (8) By comparing (7) and (8), the LU factorization can be computed recursively by the following four steps: 1) Compute L t1t1 and U t1t1 by H-LU factorization Y t1t1 = L t1t1 U t1t1 ; 2) Compute U t1t2 by solving L t1t1 U t1t2 = Y t1t2 ; 3) Compute L t2t1 by solving L t2t1 U t1t1 = Y t2t1 ; and 4) Compute L t2t2 and U t2t2 by H-LU factorization L t2t2 U t2t2 = Y t2t2 L t2t1 U t1t2. If t t is a leaf block, Y tt is not subdivided. It is stored in full matrix format, and factorized by a conventional pivoted LU factorization. Matrix solution by backward and forward substitution can be done in a similar hierarchical way Acceleration by Nested Dissection It is known that the smaller the number of nonzero elements to be processed in LU factorization, the better the computational efficiency. Nested dissection [7] can be used as an ordering technique to reduce the number of non-zero blocks to be computed in the LU factorization. In addition, this scheme naturally fits the H-based framework compared to many other ordering techniques. It serves an efficient approach to construct a block cluster tree [5]. We divide the computational domain into three parts: two domain clusters D1 and D2 which do not interact with each other and one interface cluster I which interacts with both domain clusters. Since the domain clusters D1 and D2 do not have interaction, their crosstalk entries in the FEM matrix Y are all zero. If we order the in D1 and D2 first and the in I last, the resultant matrix will have large zero blocks. These zero blocks are preserved during the LU factorization, and hence the computation cost of LU factorization is reduced. We further partition the domain clusters D1 and D2 into three parts. This process continues until the number of in each cluster is smaller than leafsize (n min ), or no interface edges can be found to divide the domain. Since the matrices in the non-zero blocks are stored and processed by H-matrix techniques in the proposed direct solver, the computational complexity is significantly reduced compared to a conventional nested dissection based LU factorization. 4. COMPLEXITY AND ACCURACY ANALYSIS 4.1. Complexity Analysis The storage complexity and inverse complexity of an H-matrix are shown to be O(kN logn), and O(kN log 2 N) respectively in [6] for solving electrodynamic problems. Here, we only analyze the complexity of an H-based LU factorization. As can be seen from Section 3.1, the LU factorization of Y tt is computed in four steps. In these four steps, Y t1t1, Y t1t2, and Y t2t1 are computed once, Y t2t2 is computed twice. Since in inverse, each block is computed twice, the complexity of H-based LU factorization is bounded by the H-based inverse, which is O(Nlog 2 N) Accuracy Analysis From the proof given in Section 2, it can be seen that the inverse of the FEM matrix Y has an H-matrix-based representation. In such a representation, which block is admissible and which block is inadmissible are determined by an admissibility condition [5, 6]. Rigorously speaking, this admissibility condition should be defined based on Y 1. However, since Y 1 is unknown, we determine it based on Y. Apparently, this will induce error. However, as analyzed in Section 2, the Y s inverse can be mapped to the dense matrix formed for an integral operator. For this dense matrix, the admissibility condition used to construct an H-matrix representation has the same form as that used in the representation of the FEM matrix Y [10, 12]. Thus, the H-matrix structure, i.e, which block can have a potential low-rank approximation and which block is a full matrix, is formed correctly for Y 1. In addition, the accuracy of the admissibility condition can be controlled. In the LU factorization process, the rank of each admissible block is adaptively determined based on a required level of accuracy. If the rank is determined to be a full rank based on the adaptive scheme, then a full rank will be used. Thus, the low-rank approximation for each admissible block is also error controllable. Based on the aforementioned two facts, the error of the proposed direct solver is controllable.

4 PIERS ONLINE, VOL. 6, NO. 7, D = 1000 um, W = 100 um, S = 50 um Metal conductivity: S/m Perfect electric conductor D 15 um 15 um ε 650 um, r = um, r = 3.4 The bottom is backed by a perfect electric conductor ε W S W Figure 1: Geometry and material of a package inductor. Figure 2: A 7 7 inductor array. CPU time (s) O(Nlog 2 N) CPU time (s) O(NlogN) storage (GB) O(NlogN) LU error A-LU / A Figure 3: Performance of the proposed LU-based direct solver for simulating an inductor array from a 2 2 array to a 7 7 array. (a) CPU time for LU factorization. (b) CPU time for solving one right hand side. (c) Storage. (d) Accuracy. 5. NUMERICAL RESULTS A package inductor array is simulated to demonstrate the accuracy and efficiency of the proposed direct solver. The configuration of each inductor is shown in Figure 1, and a 7 7 inductor array is shown in Figure 2. In this example, H-LU factorization with nested dissection is used to directly solve the FEM matrix. Simulation is done at 10 GHz for the inductor array from 2 2 to 7 7, the number of of which is from 117,287 to 1,415,127. The simulation parameters were chosen as: n min = 32 and η = 1. The rank k was adaptively decided. In Figure 3(a), we plot the LU factorization time of the proposed direct solver, and that of 5.0 with respect to the number of. The proposed solver demonstrates a complexity of O(Nlog 2 N), which agrees very well with the theoretical analysis, whereas has a much higher complexity. In Figure 3(b), we plot the matrix solution time of the proposed direct solver, and that of for one right hand side. Once again, the proposed direct solver outperforms. In addition, the proposed direct solver is shown to have an O(N logn) complexity in matrix solution (backward and forward substitution). In Figure 3(c), we plot the storage requirement of the proposed direct solver and that of in simulating this example. Even though the storage of the proposed solver is shown to be a little bit higher than that of, the complexity of the proposed solver is lower, and hence for larger number of, the proposed solver will outperform in storage. In Figure 3(d), we plot the relative error of the proposed direct FEM solver. Good accuracy is observed in the entire range. The proposed direct FEM solver has also been successfully applied to the modeling of on-chip circuits. 6. CONCLUSIONS In this work, we proved the existence of an H-matrix-based representation of the inverse of the FEM matrix for solving electrodynamic problems. We developed a direct LU-based FEM solver of significantly reduced complexity. The time and storage complexity were shown to be O(Nlog 2 N)

5 PIERS ONLINE, VOL. 6, NO. 7, and O(N logn) respectively. In addition, we accelerated the direct solver by nested dissection. Numerical experiments and a comparison with the state-of-the-art sparse matrix solver have demonstrated its superior performance in modeling large-scale circuit and package problems involving millions of. ACKNOWLEDGMENT This work was supported by NSF under award No and No REFERENCES 1. Hackbusch, W. and B. Khoromaskij, A sparse matrix arithmetic based on matrices. Part I: Introduction to matrices, Computing, Vol. 62, , Hackbusch, W. and B. N. Khoromskij, A sparse-matrix arithmetic. Part II: Application to multi-dimensional problems, Computing, Vol. 64, 21 47, Borm, S., L. Grasedyck, and W. Hackbusch, Hierarchical matrices, Lecture Note 21 of the Max Planck Institute for Mathematics in the Sciences, Grasedyck, L. and W. Hackbusch, Construction and arithmetics of matrices, Computing, Vol. 70, No. 4, , August Liu, H. and D. Jiao, A direct finite-element-based solver of significantly reduced complexity for solving large-scale electromagnetic problems, International Microwave Symposium (IMS), 4, June Liu, H. and D. Jiao, Performance analysis of the H-matrix-based fast direct solver for finiteelement-based analysis of electromagnetic problems, IEEE International Symposium on Antennas and Propagation, 4, June George, A., Nested dissection of a regular finite element mesh, SIAM J. on Numerical Analysis, Vol. 10, No. 2, , April Bebendorf, M. and W. Hackbusch, Existence of H-matrix approximants to the inverse FEmatrix of elliptic operators with L -coefficients, Numerische Mathematik, Vol. 95, 1 28, , Chai, W. and D. Jiao, H- and H 2 -matrix-based fast integral-equation solvers for large-scale electromagnetic analysis, IET Microwaves, Antennas & Propagation, accepted for publication, Chai, W. and D. Jiao, An H 2 -matrix-based integral-equation solver of reduced complexity and controlled accuracy for solving electrodynamic problems, IEEE Trans. Antennas Propagat., Vol. 57, No. 10, , October Chai, W. and D. Jiao, An H 2 -matrix-based integral-equation solver of linear-complexity for large-scale full-wave modeling of 3D circuits, IEEE 17th Conference on Electrical Performance of Electronic Packaging (EPEP), , October 2008.

COMPARED to other computational electromagnetic

COMPARED to other computational electromagnetic IEEE TRANSACTIONS ON MICROWAVE THEORY AND TECHNIQUES, VOL. 58, NO. 12, DECEMBER 2010 3697 Existence of -Matrix Representations of the Inverse Finite-Element Matrix of Electrodynamic Problems and -Based

More information

Fast Direct Volume Integral Equation Solvers For Large-Scale General Electromagnetic Analysis by Saad Omar

Fast Direct Volume Integral Equation Solvers For Large-Scale General Electromagnetic Analysis by Saad Omar Forum for Electromagnetic Research Methods and Application Technologies (FERMAT) Fast Direct Volume Integral Equation Solvers For Large-Scale General Electromagnetic Analysis by Saad Omar Final Examination

More information

An Adaptive Hierarchical Matrix on Point Iterative Poisson Solver

An Adaptive Hierarchical Matrix on Point Iterative Poisson Solver Malaysian Journal of Mathematical Sciences 10(3): 369 382 (2016) MALAYSIAN JOURNAL OF MATHEMATICAL SCIENCES Journal homepage: http://einspem.upm.edu.my/journal An Adaptive Hierarchical Matrix on Point

More information

Fast Low-Frequency Surface Integral Equation Solver Based on Hierarchical Matrix Algorithm

Fast Low-Frequency Surface Integral Equation Solver Based on Hierarchical Matrix Algorithm Progress In Electromagnetics Research, Vol. 161, 19 33, 2018 Fast Low-Frequency Surface Integral Equation Solver Based on Hierarchical Matrix Algorithm Ting Wan 1, *,QiI.Dai 2, and Weng Cho Chew 3 Abstract

More information

THE H 2 -matrix is a general mathematical framework [1],

THE H 2 -matrix is a general mathematical framework [1], Accuracy Directly Controlled Fast Direct Solutions of General H -Matrices and ts Application to Electrically Large ntegral-equation-based Electromagnetic Analysis Miaomiao Ma, Student Member, EEE, and

More information

Scientific Computing

Scientific Computing Scientific Computing Direct solution methods Martin van Gijzen Delft University of Technology October 3, 2018 1 Program October 3 Matrix norms LU decomposition Basic algorithm Cost Stability Pivoting Pivoting

More information

Hierarchical Matrices. Jon Cockayne April 18, 2017

Hierarchical Matrices. Jon Cockayne April 18, 2017 Hierarchical Matrices Jon Cockayne April 18, 2017 1 Sources Introduction to Hierarchical Matrices with Applications [Börm et al., 2003] 2 Sources Introduction to Hierarchical Matrices with Applications

More information

Fast matrix algebra for dense matrices with rank-deficient off-diagonal blocks

Fast matrix algebra for dense matrices with rank-deficient off-diagonal blocks CHAPTER 2 Fast matrix algebra for dense matrices with rank-deficient off-diagonal blocks Chapter summary: The chapter describes techniques for rapidly performing algebraic operations on dense matrices

More information

3294 IEEE TRANSACTIONS ON MICROWAVE THEORY AND TECHNIQUES, VOL. 59, NO. 12, DECEMBER 2011

3294 IEEE TRANSACTIONS ON MICROWAVE THEORY AND TECHNIQUES, VOL. 59, NO. 12, DECEMBER 2011 3294 IEEE TRANSACTIONS ON MICROWAVE THEORY AND TECHNIQUES, VOL. 59, NO. 12, DECEMBER 2011 A Rigorous Solution to the Low-Frequency Breakdown in Full-Wave Finite-Element-Based Analysis of General Problems

More information

A Deterministic-Solution Based Fast Eigenvalue Solver With Guaranteed Convergence for Finite-Element Based 3-D Electromagnetic Analysis

A Deterministic-Solution Based Fast Eigenvalue Solver With Guaranteed Convergence for Finite-Element Based 3-D Electromagnetic Analysis IEEE TRANSACTIONS ON ANTENNAS AND PROPAGATION, VOL. 61, NO. 7, JULY 2013 3701 A Deterministic-Solution Based Fast Eigenvalue Solver With Guaranteed Convergence for Finite-Element Based 3-D Electromagnetic

More information

Fast algorithms for hierarchically semiseparable matrices

Fast algorithms for hierarchically semiseparable matrices NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. 2010; 17:953 976 Published online 22 December 2009 in Wiley Online Library (wileyonlinelibrary.com)..691 Fast algorithms for hierarchically

More information

Hybrid Cross Approximation for the Electric Field Integral Equation

Hybrid Cross Approximation for the Electric Field Integral Equation Progress In Electromagnetics Research M, Vol. 75, 79 90, 2018 Hybrid Cross Approximation for the Electric Field Integral Equation Priscillia Daquin, Ronan Perrussel, and Jean-René Poirier * Abstract The

More information

FAST STRUCTURED EIGENSOLVER FOR DISCRETIZED PARTIAL DIFFERENTIAL OPERATORS ON GENERAL MESHES

FAST STRUCTURED EIGENSOLVER FOR DISCRETIZED PARTIAL DIFFERENTIAL OPERATORS ON GENERAL MESHES Proceedings of the Project Review, Geo-Mathematical Imaging Group Purdue University, West Lafayette IN, Vol. 1 2012 pp. 123-132. FAST STRUCTURED EIGENSOLVER FOR DISCRETIZED PARTIAL DIFFERENTIAL OPERATORS

More information

BALANCING-RELATED MODEL REDUCTION FOR DATA-SPARSE SYSTEMS

BALANCING-RELATED MODEL REDUCTION FOR DATA-SPARSE SYSTEMS BALANCING-RELATED Peter Benner Professur Mathematik in Industrie und Technik Fakultät für Mathematik Technische Universität Chemnitz Computational Methods with Applications Harrachov, 19 25 August 2007

More information

Pre-Corrected FFT/AIM Algorithm for. Department of Electrical & Computer Engineering

Pre-Corrected FFT/AIM Algorithm for. Department of Electrical & Computer Engineering A Multigrid Enhanced Pre-Corrected FF/AIM Algorithm for Multiscale Integral Equation Analysis K. Yang, F. Wei, and A. E. Yilmaz Department of Electrical & Computer Engineering University of exas at Austin

More information

From O(k 2 N) to O(N): A Fast and High-Capacity Eigenvalue Solver for Full-Wave Extraction of Very Large-Scale On-Chip Interconnects

From O(k 2 N) to O(N): A Fast and High-Capacity Eigenvalue Solver for Full-Wave Extraction of Very Large-Scale On-Chip Interconnects 1 From O(k N) to O(N): A Fast and High-Capacity Eigenvalue Solver for Full-Wave Extraction of Very Large-Scale On-Chip Interconnects Jongwon Lee, Venkataramanan Balakrishnan, Cheng-Kok Koh, and Dan Jiao

More information

Research Article Hierarchical Matrices Method and Its Application in Electromagnetic Integral Equations

Research Article Hierarchical Matrices Method and Its Application in Electromagnetic Integral Equations Antennas and Propagation Volume 212, Article ID 756259, 9 pages doi:1.1155/212/756259 Research Article Hierarchical Matrices Method and Its Application in Electromagnetic Integral Equations Han Guo, Jun

More information

MULTI-LAYER HIERARCHICAL STRUCTURES AND FACTORIZATIONS

MULTI-LAYER HIERARCHICAL STRUCTURES AND FACTORIZATIONS MULTI-LAYER HIERARCHICAL STRUCTURES AND FACTORIZATIONS JIANLIN XIA Abstract. We propose multi-layer hierarchically semiseparable MHS structures for the fast factorizations of dense matrices arising from

More information

Block Low-Rank (BLR) approximations to improve multifrontal sparse solvers

Block Low-Rank (BLR) approximations to improve multifrontal sparse solvers Block Low-Rank (BLR) approximations to improve multifrontal sparse solvers Joint work with Patrick Amestoy, Cleve Ashcraft, Olivier Boiteau, Alfredo Buttari and Jean-Yves L Excellent, PhD started on October

More information

Fast Multipole Methods: Fundamentals & Applications. Ramani Duraiswami Nail A. Gumerov

Fast Multipole Methods: Fundamentals & Applications. Ramani Duraiswami Nail A. Gumerov Fast Multipole Methods: Fundamentals & Applications Ramani Duraiswami Nail A. Gumerov Week 1. Introduction. What are multipole methods and what is this course about. Problems from physics, mathematics,

More information

A Fast Direct Solver for a Class of Elliptic Partial Differential Equations

A Fast Direct Solver for a Class of Elliptic Partial Differential Equations J Sci Comput (2009) 38: 316 330 DOI 101007/s10915-008-9240-6 A Fast Direct Solver for a Class of Elliptic Partial Differential Equations Per-Gunnar Martinsson Received: 20 September 2007 / Revised: 30

More information

H 2 -matrices with adaptive bases

H 2 -matrices with adaptive bases 1 H 2 -matrices with adaptive bases Steffen Börm MPI für Mathematik in den Naturwissenschaften Inselstraße 22 26, 04103 Leipzig http://www.mis.mpg.de/ Problem 2 Goal: Treat certain large dense matrices

More information

Computational Electromagnetics Definitions, applications and research

Computational Electromagnetics Definitions, applications and research Computational Electromagnetics Definitions, applications and research Luis E. Tobón Pontificia Universidad Javeriana Seminario de investigación Departamento de Electrónica y Ciencias de la Computación

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences)

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) Lecture 19: Computing the SVD; Sparse Linear Systems Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical

More information

Max-Planck-Institut fur Mathematik in den Naturwissenschaften Leipzig H 2 -matrix approximation of integral operators by interpolation by Wolfgang Hackbusch and Steen Borm Preprint no.: 04 200 H 2 -Matrix

More information

Improvements for Implicit Linear Equation Solvers

Improvements for Implicit Linear Equation Solvers Improvements for Implicit Linear Equation Solvers Roger Grimes, Bob Lucas, Clement Weisbecker Livermore Software Technology Corporation Abstract Solving large sparse linear systems of equations is often

More information

Scientific Computing with Case Studies SIAM Press, Lecture Notes for Unit VII Sparse Matrix

Scientific Computing with Case Studies SIAM Press, Lecture Notes for Unit VII Sparse Matrix Scientific Computing with Case Studies SIAM Press, 2009 http://www.cs.umd.edu/users/oleary/sccswebpage Lecture Notes for Unit VII Sparse Matrix Computations Part 1: Direct Methods Dianne P. O Leary c 2008

More information

NASA Contractor Report. Application of FEM to Estimate Complex Permittivity of Dielectric Material at Microwave Frequency Using Waveguide Measurements

NASA Contractor Report. Application of FEM to Estimate Complex Permittivity of Dielectric Material at Microwave Frequency Using Waveguide Measurements NASA Contractor Report Application of FEM to Estimate Complex Permittivity of Dielectric Material at Microwave Frequency Using Waveguide Measurements M. D.Deshpande VIGYAN Inc., Hampton, VA C. J. Reddy

More information

A DISTRIBUTED-MEMORY RANDOMIZED STRUCTURED MULTIFRONTAL METHOD FOR SPARSE DIRECT SOLUTIONS

A DISTRIBUTED-MEMORY RANDOMIZED STRUCTURED MULTIFRONTAL METHOD FOR SPARSE DIRECT SOLUTIONS A DISTRIBUTED-MEMORY RANDOMIZED STRUCTURED MULTIFRONTAL METHOD FOR SPARSE DIRECT SOLUTIONS ZIXING XIN, JIANLIN XIA, MAARTEN V. DE HOOP, STEPHEN CAULEY, AND VENKATARAMANAN BALAKRISHNAN Abstract. We design

More information

Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota

Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota SIAM CSE Boston - March 1, 2013 First: Joint work with Ruipeng Li Work

More information

SUMMARY INTRODUCTION BLOCK LOW-RANK MULTIFRONTAL METHOD

SUMMARY INTRODUCTION BLOCK LOW-RANK MULTIFRONTAL METHOD D frequency-domain seismic modeling with a Block Low-Rank algebraic multifrontal direct solver. C. Weisbecker,, P. Amestoy, O. Boiteau, R. Brossier, A. Buttari, J.-Y. L Excellent, S. Operto, J. Virieux

More information

A DISTRIBUTED-MEMORY RANDOMIZED STRUCTURED MULTIFRONTAL METHOD FOR SPARSE DIRECT SOLUTIONS

A DISTRIBUTED-MEMORY RANDOMIZED STRUCTURED MULTIFRONTAL METHOD FOR SPARSE DIRECT SOLUTIONS SIAM J. SCI. COMPUT. Vol. 39, No. 4, pp. C292 C318 c 2017 Society for Industrial and Applied Mathematics A DISTRIBUTED-MEMORY RANDOMIZED STRUCTURED MULTIFRONTAL METHOD FOR SPARSE DIRECT SOLUTIONS ZIXING

More information

An Explicit and Unconditionally Stable FDTD Method for Electromagnetic Analysis

An Explicit and Unconditionally Stable FDTD Method for Electromagnetic Analysis IEEE TRANSACTIONS ON MICROWAVE THEORY AND TECHNIQUES 1 An Explicit and Unconditionally Stable FDTD Method for Electromagnetic Analysis Md. Gaffar and Dan Jiao, Senior Member, IEEE Abstract In this paper,

More information

Numerical Analysis of Electromagnetic Fields in Multiscale Model

Numerical Analysis of Electromagnetic Fields in Multiscale Model Commun. Theor. Phys. 63 (205) 505 509 Vol. 63, No. 4, April, 205 Numerical Analysis of Electromagnetic Fields in Multiscale Model MA Ji ( ), FANG Guang-You (ྠ), and JI Yi-Cai (Π) Key Laboratory of Electromagnetic

More information

Numerical Methods I: Numerical linear algebra

Numerical Methods I: Numerical linear algebra 1/3 Numerical Methods I: Numerical linear algebra Georg Stadler Courant Institute, NYU stadler@cimsnyuedu September 1, 017 /3 We study the solution of linear systems of the form Ax = b with A R n n, x,

More information

COLLOCATED SIBC-FDTD METHOD FOR COATED CONDUCTORS AT OBLIQUE INCIDENCE

COLLOCATED SIBC-FDTD METHOD FOR COATED CONDUCTORS AT OBLIQUE INCIDENCE Progress In Electromagnetics Research M, Vol. 3, 239 252, 213 COLLOCATED SIBC-FDTD METHOD FOR COATED CONDUCTORS AT OBLIQUE INCIDENCE Lijuan Shi 1, 3, Lixia Yang 2, *, Hui Ma 2, and Jianning Ding 3 1 School

More information

Solving an Elliptic PDE Eigenvalue Problem via Automated Multi-Level Substructuring and Hierarchical Matrices

Solving an Elliptic PDE Eigenvalue Problem via Automated Multi-Level Substructuring and Hierarchical Matrices Solving an Elliptic PDE Eigenvalue Problem via Automated Multi-Level Substructuring and Hierarchical Matrices Peter Gerds and Lars Grasedyck Bericht Nr. 30 März 2014 Key words: automated multi-level substructuring,

More information

Enhancing Scalability of Sparse Direct Methods

Enhancing Scalability of Sparse Direct Methods Journal of Physics: Conference Series 78 (007) 0 doi:0.088/7-6596/78//0 Enhancing Scalability of Sparse Direct Methods X.S. Li, J. Demmel, L. Grigori, M. Gu, J. Xia 5, S. Jardin 6, C. Sovinec 7, L.-Q.

More information

Application of AWE for RCS frequency response calculations using Method of Moments

Application of AWE for RCS frequency response calculations using Method of Moments NASA Contractor Report 4758 Application of AWE for RCS frequency response calculations using Method of Moments C.J.Reddy Hampton University, Hampton, Virginia M.D.Deshpande ViGYAN Inc., Hampton, Virginia

More information

APPROXIMATING GAUSSIAN PROCESSES

APPROXIMATING GAUSSIAN PROCESSES 1 / 23 APPROXIMATING GAUSSIAN PROCESSES WITH H 2 -MATRICES Steffen Börm 1 Jochen Garcke 2 1 Christian-Albrechts-Universität zu Kiel 2 Universität Bonn and Fraunhofer SCAI 2 / 23 OUTLINE 1 GAUSSIAN PROCESSES

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

Effective matrix-free preconditioning for the augmented immersed interface method

Effective matrix-free preconditioning for the augmented immersed interface method Effective matrix-free preconditioning for the augmented immersed interface method Jianlin Xia a, Zhilin Li b, Xin Ye a a Department of Mathematics, Purdue University, West Lafayette, IN 47907, USA. E-mail:

More information

Sparse factorization using low rank submatrices. Cleve Ashcraft LSTC 2010 MUMPS User Group Meeting April 15-16, 2010 Toulouse, FRANCE

Sparse factorization using low rank submatrices. Cleve Ashcraft LSTC 2010 MUMPS User Group Meeting April 15-16, 2010 Toulouse, FRANCE Sparse factorization using low rank submatrices Cleve Ashcraft LSTC cleve@lstc.com 21 MUMPS User Group Meeting April 15-16, 21 Toulouse, FRANCE ftp.lstc.com:outgoing/cleve/mumps1 Ashcraft.pdf 1 LSTC Livermore

More information

V C V L T I 0 C V B 1 V T 0 I. l nk

V C V L T I 0 C V B 1 V T 0 I. l nk Multifrontal Method Kailai Xu September 16, 2017 Main observation. Consider the LDL T decomposition of a SPD matrix [ ] [ ] [ ] [ ] B V T L 0 I 0 L T L A = = 1 V T V C V L T I 0 C V B 1 V T, 0 I where

More information

FAST AND ACCURATE RADAR CROSS SECTION COM- PUTATION USING CHEBYSHEV APPROXIMATION IN BOTH BROAD FREQUENCY BAND AND ANGULAR DOMAINS SIMULTANEOUSLY

FAST AND ACCURATE RADAR CROSS SECTION COM- PUTATION USING CHEBYSHEV APPROXIMATION IN BOTH BROAD FREQUENCY BAND AND ANGULAR DOMAINS SIMULTANEOUSLY Progress In Electromagnetics Research Letters, Vol. 13, 121 129, 2010 FAST AND ACCURATE RADAR CROSS SECTION COM- PUTATION USING CHEBYSHEV APPROXIMATION IN BOTH BROAD FREQUENCY BAND AND ANGULAR DOMAINS

More information

A Sparse QS-Decomposition for Large Sparse Linear System of Equations

A Sparse QS-Decomposition for Large Sparse Linear System of Equations A Sparse QS-Decomposition for Large Sparse Linear System of Equations Wujian Peng 1 and Biswa N. Datta 2 1 Department of Math, Zhaoqing University, Zhaoqing, China, douglas peng@yahoo.com 2 Department

More information

Numerical Linear Algebra

Numerical Linear Algebra Numerical Linear Algebra Decompositions, numerical aspects Gerard Sleijpen and Martin van Gijzen September 27, 2017 1 Delft University of Technology Program Lecture 2 LU-decomposition Basic algorithm Cost

More information

Program Lecture 2. Numerical Linear Algebra. Gaussian elimination (2) Gaussian elimination. Decompositions, numerical aspects

Program Lecture 2. Numerical Linear Algebra. Gaussian elimination (2) Gaussian elimination. Decompositions, numerical aspects Numerical Linear Algebra Decompositions, numerical aspects Program Lecture 2 LU-decomposition Basic algorithm Cost Stability Pivoting Cholesky decomposition Sparse matrices and reorderings Gerard Sleijpen

More information

ARTICLE IN PRESS. Available online at Mathematics and Computers in Simulation xxx (2009) xxx xxx

ARTICLE IN PRESS. Available online at  Mathematics and Computers in Simulation xxx (2009) xxx xxx Available online at www.sciencedirect.com Mathematics and Computers in Simulation xxx (2009) xxx xxx Fill-ins number reducing direct solver designed for FIT-type matrix Michał Dobrzyński, Jagoda Plata

More information

Partial Left-Looking Structured Multifrontal Factorization & Algorithms for Compressed Sensing. Cinna Julie Wu

Partial Left-Looking Structured Multifrontal Factorization & Algorithms for Compressed Sensing. Cinna Julie Wu Partial Left-Looking Structured Multifrontal Factorization & Algorithms for Compressed Sensing by Cinna Julie Wu A dissertation submitted in partial satisfaction of the requirements for the degree of Doctor

More information

A Parallel Geometric Multifrontal Solver Using Hierarchically Semiseparable Structure

A Parallel Geometric Multifrontal Solver Using Hierarchically Semiseparable Structure Page 26 of 46 A Parallel Geometric Multifrontal Solver Using Hierarchically Semiseparable Structure SHEN WANG, Department of Mathematics, Purdue University XIAOYE S. LI, Lawrence Berkeley National Laboratory

More information

Incomplete Cholesky preconditioners that exploit the low-rank property

Incomplete Cholesky preconditioners that exploit the low-rank property anapov@ulb.ac.be ; http://homepages.ulb.ac.be/ anapov/ 1 / 35 Incomplete Cholesky preconditioners that exploit the low-rank property (theory and practice) Artem Napov Service de Métrologie Nucléaire, Université

More information

ERROR CONVERGENCE ANALYSIS FOR LOCAL HYPERTHERMIA APPLICATIONS

ERROR CONVERGENCE ANALYSIS FOR LOCAL HYPERTHERMIA APPLICATIONS Journal of Engineering Science and Technology Vol. 11, No. 1 (2016) 060-067 School of Engineering, Taylor s University ERROR CONVERGENCE ANALYSIS FOR LOCAL HYPERTHERMIA APPLICATIONS NEERU MALHOTRA 1, *,

More information

AN EFFICIENT APPROACH FOR MULTIFRONTAL AL- GORITHM TO SOLVE NON-POSITIVE-DEFINITE FI- NITE ELEMENT EQUATIONS IN ELECTROMAGNETIC PROBLEMS

AN EFFICIENT APPROACH FOR MULTIFRONTAL AL- GORITHM TO SOLVE NON-POSITIVE-DEFINITE FI- NITE ELEMENT EQUATIONS IN ELECTROMAGNETIC PROBLEMS Progress In Electromagnetics Research, PIER 95, 2 33, 29 AN EFFICIENT APPROACH FOR MULTIFRONTAL AL- GORITHM TO SOLVE NON-POSITIVE-DEFINITE FI- NITE ELEMENT EQUATIONS IN ELECTROMAGNETIC PROBLEMS J. Tian,

More information

Direct solution methods for sparse matrices. p. 1/49

Direct solution methods for sparse matrices. p. 1/49 Direct solution methods for sparse matrices p. 1/49 p. 2/49 Direct solution methods for sparse matrices Solve Ax = b, where A(n n). (1) Factorize A = LU, L lower-triangular, U upper-triangular. (2) Solve

More information

/$ IEEE

/$ IEEE 1138 IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 28, NO. 8, AUGUST 2009 Time-Domain Orthogonal Finite-Element Reduction-Recovery Method for Electromagnetics-Based

More information

Review of Some Fast Algorithms for Electromagnetic Scattering

Review of Some Fast Algorithms for Electromagnetic Scattering Review of Some Fast Algorithms for Electromagnetic Scattering Weng Cho Chew Center for Computational Electromagnetics and Electromagnetic Laboratory University of Illinois at Urbana-Champaign CSCAMM Lecture

More information

A Symmetric and Low-Frequency Stable Potential Formulation for the Finite-Element Simulation of Electromagnetic Fields

A Symmetric and Low-Frequency Stable Potential Formulation for the Finite-Element Simulation of Electromagnetic Fields A Symmetric and Low-Frequency Stable Potential Formulation for the Finite-Element Simulation of Electromagnetic Fields Martin Jochum, Ortwin Farle, and Romanus Dyczij-Edlinger Abstract A low-frequency

More information

Matrix-Product-States/ Tensor-Trains

Matrix-Product-States/ Tensor-Trains / Tensor-Trains November 22, 2016 / Tensor-Trains 1 Matrices What Can We Do With Matrices? Tensors What Can We Do With Tensors? Diagrammatic Notation 2 Singular-Value-Decomposition 3 Curse of Dimensionality

More information

Numerical Methods I Non-Square and Sparse Linear Systems

Numerical Methods I Non-Square and Sparse Linear Systems Numerical Methods I Non-Square and Sparse Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 25th, 2014 A. Donev (Courant

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

High-speed method for analyzing shielding current density in HTS with cracks: implementation of H-matrix method to GMRES

High-speed method for analyzing shielding current density in HTS with cracks: implementation of H-matrix method to GMRES J. Adv. Simulat. Sci. Eng. Vol. 3, No. 2, 173 187. c 2016 Japan Society for Simulation Technology High-speed method for analyzing shielding current density in HTS with cracks: implementation of H-matrix

More information

Linear Equations in Linear Algebra

Linear Equations in Linear Algebra 1 Linear Equations in Linear Algebra 1.1 SYSTEMS OF LINEAR EQUATIONS LINEAR EQUATION x 1,, x n A linear equation in the variables equation that can be written in the form a 1 x 1 + a 2 x 2 + + a n x n

More information

Direct Matrix Solution of Linear Complexity for Surface Integral-Equation-Based Impedance Extraction of Complicated 3-D Structures

Direct Matrix Solution of Linear Complexity for Surface Integral-Equation-Based Impedance Extraction of Complicated 3-D Structures INVITED PAPER Direct Matrix olution of Linear Complexity for urface Integral-Equation-Based Impedance Extraction of Complicated 3-D tructures The authors of this paper develop a low-complexity matrix solution

More information

A Novel Single-Source Surface Integral Method to Compute Scattering from Dielectric Objects

A Novel Single-Source Surface Integral Method to Compute Scattering from Dielectric Objects SUBMITTED TO IEEE ANTENNAS AND WIRELESS PROPAGATION LETTERS ON NOVEMBER 18, 2016 1 A Novel Single-Source Surface Integral Method to Compute Scattering from Dielectric Objects Utkarsh R. Patel, Student

More information

Parallel Numerical Algorithms

Parallel Numerical Algorithms Parallel Numerical Algorithms Chapter 6 Matrix Models Section 6.2 Low Rank Approximation Edgar Solomonik Department of Computer Science University of Illinois at Urbana-Champaign CS 554 / CSE 512 Edgar

More information

Bridging the gap between flat and hierarchical low-rank matrix formats: the multilevel BLR format

Bridging the gap between flat and hierarchical low-rank matrix formats: the multilevel BLR format Bridging the gap between flat and hierarchical low-rank matrix formats: the multilevel BLR format Amestoy, Patrick and Buttari, Alfredo and L Excellent, Jean-Yves and Mary, Theo 2018 MIMS EPrint: 2018.12

More information

Higher order hierarchical H(curl) Legendre basis functions applied in the finite element method: emphasis on microwave circuits

Higher order hierarchical H(curl) Legendre basis functions applied in the finite element method: emphasis on microwave circuits Higher order hierarchical H(curl) Legendre basis functions applied in the finite element method: emphasis on microwave circuits Johannesson, Peter 20 Link to publication Citation for published version

More information

J.I. Aliaga 1 M. Bollhöfer 2 A.F. Martín 1 E.S. Quintana-Ortí 1. March, 2009

J.I. Aliaga 1 M. Bollhöfer 2 A.F. Martín 1 E.S. Quintana-Ortí 1. March, 2009 Parallel Preconditioning of Linear Systems based on ILUPACK for Multithreaded Architectures J.I. Aliaga M. Bollhöfer 2 A.F. Martín E.S. Quintana-Ortí Deparment of Computer Science and Engineering, Univ.

More information

5.1 Banded Storage. u = temperature. The five-point difference operator. uh (x, y + h) 2u h (x, y)+u h (x, y h) uh (x + h, y) 2u h (x, y)+u h (x h, y)

5.1 Banded Storage. u = temperature. The five-point difference operator. uh (x, y + h) 2u h (x, y)+u h (x, y h) uh (x + h, y) 2u h (x, y)+u h (x h, y) 5.1 Banded Storage u = temperature u= u h temperature at gridpoints u h = 1 u= Laplace s equation u= h u = u h = grid size u=1 The five-point difference operator 1 u h =1 uh (x + h, y) 2u h (x, y)+u h

More information

A sparse multifrontal solver using hierarchically semi-separable frontal matrices

A sparse multifrontal solver using hierarchically semi-separable frontal matrices A sparse multifrontal solver using hierarchically semi-separable frontal matrices Pieter Ghysels Lawrence Berkeley National Laboratory Joint work with: Xiaoye S. Li (LBNL), Artem Napov (ULB), François-Henry

More information

Efficient Analysis of Rectangular-Shape Metamaterials Using P-CBFM/p-FFT Method

Efficient Analysis of Rectangular-Shape Metamaterials Using P-CBFM/p-FFT Method Progress In Electromagnetics Research M, Vol. 51, 121 129, 2016 Efficient Analysis of Rectangular-Shape Metamaterials Using P-CBFM/p-FFT Method Ke Xiao *, Huiying Qi, Sheng Shui Wang, Ying Liu, Liang Ding,

More information

Contents. Preface... xi. Introduction...

Contents. Preface... xi. Introduction... Contents Preface... xi Introduction... xv Chapter 1. Computer Architectures... 1 1.1. Different types of parallelism... 1 1.1.1. Overlap, concurrency and parallelism... 1 1.1.2. Temporal and spatial parallelism

More information

Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques

Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques Institut für Numerische Mathematik und Optimierung Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques Oliver Ernst Computational Methods with Applications Harrachov, CR,

More information

A direct solver for elliptic PDEs in three dimensions based on hierarchical merging of Poincaré-Steklov operators

A direct solver for elliptic PDEs in three dimensions based on hierarchical merging of Poincaré-Steklov operators (1) A direct solver for elliptic PDEs in three dimensions based on hierarchical merging of Poincaré-Steklov operators S. Hao 1, P.G. Martinsson 2 Abstract: A numerical method for variable coefficient elliptic

More information

Calculate Sensitivity Function Using Parallel Algorithm

Calculate Sensitivity Function Using Parallel Algorithm Journal of Computer Science 4 (): 928-933, 28 ISSN 549-3636 28 Science Publications Calculate Sensitivity Function Using Parallel Algorithm Hamed Al Rjoub Irbid National University, Irbid, Jordan Abstract:

More information

Sparse Matrices and Iterative Methods

Sparse Matrices and Iterative Methods Sparse Matrices and Iterative Methods K. 1 1 Department of Mathematics 2018 Iterative Methods Consider the problem of solving Ax = b, where A is n n. Why would we use an iterative method? Avoid direct

More information

1420 IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 24, NO. 9, SEPTEMBER 2005

1420 IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 24, NO. 9, SEPTEMBER 2005 14 IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 4, NO. 9, SEPTEMBER 5 Sparse Transformations and Preconditioners for 3-D Capacitance Extraction Shu Yan, Student Member,

More information

Sparsity-Preserving Difference of Positive Semidefinite Matrix Representation of Indefinite Matrices

Sparsity-Preserving Difference of Positive Semidefinite Matrix Representation of Indefinite Matrices Sparsity-Preserving Difference of Positive Semidefinite Matrix Representation of Indefinite Matrices Jaehyun Park June 1 2016 Abstract We consider the problem of writing an arbitrary symmetric matrix as

More information

Evaluation of the Sacttering Matrix of Flat Dipoles Embedded in Multilayer Structures

Evaluation of the Sacttering Matrix of Flat Dipoles Embedded in Multilayer Structures PIERS ONLINE, VOL. 4, NO. 5, 2008 536 Evaluation of the Sacttering Matrix of Flat Dipoles Embedded in Multilayer Structures S. J. S. Sant Anna 1, 2, J. C. da S. Lacava 2, and D. Fernandes 2 1 Instituto

More information

LOCALIZED SPARSIFYING PRECONDITIONER FOR PERIODIC INDEFINITE SYSTEMS

LOCALIZED SPARSIFYING PRECONDITIONER FOR PERIODIC INDEFINITE SYSTEMS COMMUN. MATH. SCI. Vol., No., pp. 7 7 c 7 International Press LOCALIZED SPARSIFYING PRECONDITIONER FOR PERIODIC INDEFINITE SYSTEMS FEI LIU AND LEXING YING Abstract. This paper introduces the localized

More information

An Introduction to Hierachical (H ) Rank and TT Rank of Tensors with Examples

An Introduction to Hierachical (H ) Rank and TT Rank of Tensors with Examples An Introduction to Hierachical (H ) Rank and TT Rank of Tensors with Examples Lars Grasedyck and Wolfgang Hackbusch Bericht Nr. 329 August 2011 Key words: MSC: hierarchical Tucker tensor rank tensor approximation

More information

A High-Performance Parallel Hybrid Method for Large Sparse Linear Systems

A High-Performance Parallel Hybrid Method for Large Sparse Linear Systems Outline A High-Performance Parallel Hybrid Method for Large Sparse Linear Systems Azzam Haidar CERFACS, Toulouse joint work with Luc Giraud (N7-IRIT, France) and Layne Watson (Virginia Polytechnic Institute,

More information

PAPER Fast Algorithm for Solving Matrix Equation in MoM Analysis of Large-Scale Array Antennas

PAPER Fast Algorithm for Solving Matrix Equation in MoM Analysis of Large-Scale Array Antennas 2482 PAPER Fast Algorithm for Solving Matrix Equation in MoM Analysis of Large-Scale Array Antennas Qiang CHEN, Regular Member, Qiaowei YUAN, Nonmember, and Kunio SAWAYA, Regular Member SUMMARY A new iterative

More information

ELECTROMAGNETIC SCATTERING BY MIXED CONDUCTING/DIELECTRIC OBJECTS USING HIGHER-ORDER MOM

ELECTROMAGNETIC SCATTERING BY MIXED CONDUCTING/DIELECTRIC OBJECTS USING HIGHER-ORDER MOM Progress In Electromagnetics Research, PIER 66, 51 63, 2006 ELECTROMAGNETIC SCATTERING BY MIXED CONDUCTING/DIELECTRIC OBJECTS USING HIGHER-ORDER MOM S. G. Wang, X. P. Guan, D. W. Wang, X. Y. Ma, and Y.

More information

Evanescent modes stored in cavity resonators with backward-wave slabs

Evanescent modes stored in cavity resonators with backward-wave slabs arxiv:cond-mat/0212392v1 17 Dec 2002 Evanescent modes stored in cavity resonators with backward-wave slabs S.A. Tretyakov, S.I. Maslovski, I.S. Nefedov, M.K. Kärkkäinen Radio Laboratory, Helsinki University

More information

Uniform Plane Waves. Ranga Rodrigo. University of Moratuwa. November 7, 2008

Uniform Plane Waves. Ranga Rodrigo. University of Moratuwa. November 7, 2008 Uniform Plane Waves Ranga Rodrigo University of Moratuwa November 7, 2008 Ranga Rodrigo (University of Moratuwa) Uniform Plane Waves November 7, 2008 1 / 51 Summary of Last Week s Lecture Basic Relations

More information

DM545 Linear and Integer Programming. Lecture 7 Revised Simplex Method. Marco Chiarandini

DM545 Linear and Integer Programming. Lecture 7 Revised Simplex Method. Marco Chiarandini DM545 Linear and Integer Programming Lecture 7 Marco Chiarandini Department of Mathematics & Computer Science University of Southern Denmark Outline 1. 2. 2 Motivation Complexity of single pivot operation

More information

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations Sparse Linear Systems Iterative Methods for Sparse Linear Systems Matrix Computations and Applications, Lecture C11 Fredrik Bengzon, Robert Söderlund We consider the problem of solving the linear system

More information

Fast direct solvers for elliptic PDEs

Fast direct solvers for elliptic PDEs Fast direct solvers for elliptic PDEs Gunnar Martinsson The University of Colorado at Boulder Students: Adrianna Gillman (now at Dartmouth) Nathan Halko Sijia Hao Patrick Young (now at GeoEye Inc.) Collaborators:

More information

A fast randomized algorithm for the approximation of matrices preliminary report

A fast randomized algorithm for the approximation of matrices preliminary report DRAFT A fast randomized algorithm for the approximation of matrices preliminary report Yale Department of Computer Science Technical Report #1380 Franco Woolfe, Edo Liberty, Vladimir Rokhlin, and Mark

More information

THE ADI-FDTD METHOD INCLUDING LUMPED NET- WORKS USING PIECEWISE LINEAR RECURSIVE CON- VOLUTION TECHNIQUE

THE ADI-FDTD METHOD INCLUDING LUMPED NET- WORKS USING PIECEWISE LINEAR RECURSIVE CON- VOLUTION TECHNIQUE Progress In Electromagnetics Research M, Vol. 30, 67 77, 203 THE ADI-FDTD METHOD INCLUDING LUMPED NET- WORKS USING PIECEWISE LINEAR RECURSIVE CON- VOLUTION TECHNIQUE Fen Xia, Qing-Xin Chu *, Yong-Dan Kong,

More information

Transactions on Modelling and Simulation vol 19, 1998 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 19, 1998 WIT Press,   ISSN X Cost estimation of the panel clustering method applied to 3-D elastostatics Ken Hayami* & Stefan A. Sauter^ * Department of Mathematical Engineering and Information Physics, Graduate School of Engineering,

More information

Analyzing of Coupling Region for CRLH/RH TL Coupler with Lumped-elements

Analyzing of Coupling Region for CRLH/RH TL Coupler with Lumped-elements PIERS ONLINE, VOL. 3, NO. 5, 27 564 Analyzing of Coupling Region for CRLH/RH TL Coupler with Lumped-elements Y. Wang 2, Y. Zhang, 2, and F. Liu 2 Pohl Institute of Solid State Physics, Tongji University,

More information

Modeling of Multiconductor Microstrip Systems on Microwave Integrated Circuits

Modeling of Multiconductor Microstrip Systems on Microwave Integrated Circuits Modeling of Multiconductor Microstrip Systems on Microwave Integrated Circuits S. M. Musa, M. N. O. Sadiku, and K. T. Harris Roy G. Perry College of Engineering, Prairie View A&M University Prairie View,

More information

Accurate Modeling of Spiral Inductors on Silicon From Within Cadence Virtuoso using Planar EM Simulation. Agilent EEsof RFIC Seminar Spring 2004

Accurate Modeling of Spiral Inductors on Silicon From Within Cadence Virtuoso using Planar EM Simulation. Agilent EEsof RFIC Seminar Spring 2004 Accurate Modeling of Spiral Inductors on Silicon From Within Cadence Virtuoso using Planar EM Simulation Agilent EEsof RFIC Seminar Spring Overview Spiral Inductor Models Availability & Limitations Momentum

More information

Utilisation de la compression low-rank pour réduire la complexité du solveur PaStiX

Utilisation de la compression low-rank pour réduire la complexité du solveur PaStiX Utilisation de la compression low-rank pour réduire la complexité du solveur PaStiX 26 Septembre 2018 - JCAD 2018 - Lyon Grégoire Pichon, Mathieu Faverge, Pierre Ramet, Jean Roman Outline 1. Context 2.

More information

A Solenoidal Basis Method For Efficient Inductance Extraction Λ

A Solenoidal Basis Method For Efficient Inductance Extraction Λ A Solenoidal Basis Method For Efficient Inductance Extraction Λ Hemant Mahawar Department of Computer Science Texas A&M University College Station, TX 77843 mahawarh@cs.tamu.edu Vivek Sarin Department

More information

INTEGRATION minimizes size and weight, and maximizes

INTEGRATION minimizes size and weight, and maximizes 380 IEEE TRANSACTIONS ON COMPUTER-AIDED DESIGN OF INTEGRATED CIRCUITS AND SYSTEMS, VOL. 31, NO. 3, MARCH 2012 A Quadratic Eigenvalue Solver of Linear Complexity for 3-D Electromagnetics-Based Analysis

More information

From O(k 2 N) to O(N): A Fast and High-Capacity Eigenvalue Solver for Full-Wave Extraction of Very Large-Scale On-Chip Interconnects

From O(k 2 N) to O(N): A Fast and High-Capacity Eigenvalue Solver for Full-Wave Extraction of Very Large-Scale On-Chip Interconnects 1 From O(k N) to O(N): A Fast and High-Capacity Eigenvalue Solver for Full-Wave Extraction of Very Large-Scale On-Chip Interconnects Jongwon Lee, Student Member, IEEE, Venkataramanan Balakrishnan, Senior

More information