Advanced Method of Moments Based on Iterative Equation System Solvers

Size: px
Start display at page:

Download "Advanced Method of Moments Based on Iterative Equation System Solvers"

Transcription

1 Advanced Method of Moments Based on Iterative Equation System Solvers G. Burger, H.-D. Briins and H. Singer Technical University Hamburg-Harburg Department of Theoretical Electrical Engineering Hamburg, Germany Abstract: The treatment of field and scattering problems by means of method of moments (MOM) produces a system of linear equations which has to be solved. For large-scale structures the numerical effort for an LU decomposition of the system matrix becomes unacceptable. Iterative solvers can be an alternative but they often require a sophisticated preconditioner. A simple but powerful preconditioner can be derived from the physical meaning of the blocks in the impedance matrix and is applicable to a wide range of EMC problems. Using iterative methods can also be of significant advantage in another class of problems. INTRODUCTION The method of moments [5] is perhaps the most developed numerical technique to date for solving scattering and radiation problems in EMC. However the method leads to a system of linear equations that can be solved by an LU decomposition of the order 0(n3). For today s technical structures n = lo4 unknowns are not seldom and one gets an unacceptable solution time for an LU decomposition with such a high number of unknowns even on modern computers. In the past, iterative methods, e.g. conjugate gradients [9], have been tried to solve the equation system. But these early methods show poor and irregular convergence as the system matrix is mostly ill conditioned. In the last years more powerful iterative algorithms, e.g. GM- RES or QMR, have been developed with better convergence properties (for an overview, see e.g. [l]). The use of these methods for solving the equation system is at hands, but experience shows that without special techniques, good results (i.e. fast convergence and high accuracy) could only be achieved for relatively simple structures or in 2 dimensions. To get a sufficiently accurate solution for complicated EMC problems in 3 dimensions a high number of p iterations is needed. Each iteration step produces a numerical effort of the order 0(n2) which means that the complete effort will be 0(pn2). If p in comparison to n is not small there will be no benefit from the iterative method compared to the LU decomposition. There are two possibilities in order to reduce the numerical effort. On one hand the effort in the matrix-vector multiplication can be diminished. Lately some promising methods have been developed that follow this line. Some examples are the impedance matrix localization method (IML) [3], the fast multipole method (FMM) [4] or the multilevel matrix decomposition algorithm (MLMDA) [8]. These algorithms are able to reduce the required numerical effort in the matrix-vector multiplication considerably, for instance in the case of MLMDA from L3(n2) to O(n log2 n). On the other hand the overall numerical cost can also be kept low if the number of iterations p for the solution of the equation system (given certain accuracy) is small, say p 5 20 and independent from n. This can be achieved by the development of po- werful but numerically simple preconditioners. When developing such preconditioners one can sometimes adopt results from the numerical solutions of differential equations. A block Jacobi preconditioner can occasionally be motivated by domains consisting of different physical partitions. Geometrically sepa- rated parts of non-galvanically connected scatterers or multizone scatterers shall be mentioned as examples in the EMC area. In these cases the preconditioner can be easily and with little additional memory requirement derived from the given impedance matrix and a preconditioned version of the iterative solver can be used to substitute the common direct solver. Even if there is no simple preconditioner, iterative methods can still be of advantage. E.g. after a very costly preconditioner has been calculated, it can be used on and on for all steps in a frequency loop. We will first introduce the classes of EMC problems that can be well solved by iterative solvers, where one can achieve a substantial reduction of the solving time. The next section outlines the underlying theory, shows how the block structure of the impedance matrix results from the topology of the configuration and how to derive the block Jacobi preconditioner. Here is also explained how this preconditioner is usable in combination with impedance matrix transformation methods to treat shielding problems. Afterwards it will be demonstrated how an iterative solver can be used in a frequency loop. Some examples will illustrate the efficiency of the solver. We would like to point out the significance of the iterative methods in the computational electromagnetics using MOM. The interpretation of the /97/$

2 fields in each volume can be written as PEC structure El = El 11 J1 + El 22 J1 + Einc 1 > 0) Hl =?-llj ?llj Hint 1? (2b) E2 = E2J Hz =?12J2 2 2 PC) (24 The fields have to satisfy boundary conditions on the surfaces. Since S1 should be a perfect electric conductor the tangential component of the electric field strength has to vanish on S1, i.e. Figure 1: Dielectric body next to a perfect electric conductor in a plane wave field results of the examples in relation to the physical world is out of the scope of this paper, even though all examples are real life EMC problems. Finally, some conclusions and recommendations for future work will be presented. INTEGRAL EQUATIONS AND THEIR SOLUTIONS This section will demonstrate that the impedance matrix has a block structure, which results mainly from the topology of the examined configuration. This block structure gives rise to an easy but efficient preconditioner. nlxel(r)=o VrE&. W On the dielectric boundary Ss the tangential components of the electric and magnetic field strength have to be equal on both sides of S s, i.e. nzxel(r)=nzxez(r) VrESz, (3b) nzxhl(r)=nzxhz(r) VrESz. (3c) Here ni denotes the normal vector on surface Si. Utilizing the representation of the fields and the boundary condition one gets the following operator equation system Integral equation and MOM matrix Consider two surfaces Sr and Ss in free space. The open surface Si represents a perfect electric conductor whereas the closed surface Ss encircles a volume V2 which represents a dielectric body, characterized by its material constants EZ,,L~~, o? (Fig. 1). The configuration is excited by an incident field E2,, Hi and we are looking for the scattered field in free space (volume VI) and the transmitted field in the interior of S s (volume Vz). In order to calculate these fields a single layer current distribution Ji and a double layer current distribution Jf, Ji are assumed. In this notation the current Ji flows on surface Si in volume Vj. The electric and magnetic fields of these currents J{ are given by the integral operators 1 &; J{ = --jwp,, J; + I(, -J;)V kj Gj(R) ds, (14 The subscript tan indicates that only the tangential components of the fields are being considered. The method of moments [5] is employed to solve the operator system. For the purpose, the surfaces Si are divided into patches and on every two patches with a common edge a basis and a test function are defined. This produces n basis and n test functions. The particular surface currents J{ on surface Si in volume Vj are expanded to these n basis functions and will be inserted into the operator system. Subsequently the scalar product with each of the n test functions will be worked out. If one uses an ordering of the basis and test function according to the surfaces and volumes, this will transform the operator system into the following linear block equation system with $J< = z 2 J{ x VGj (R) ds (lb) s Si being the Greens function and Icj being the wave number in volume Vj. With these (equivalent electric) surface currents the where 2 is a n x n matrix and I, U are vectors of the length n. Note that the impedance matrix 2 has a block structure, which can be interpreted: The diagonal blocks describe the interaction of structure parts with itself (self interaction) and off-diagonal blocks describe the interaction between different structure parts. A zero block in the impedance matrix illustrates that there is no interaction between the corresponding parts. 237

3 Block Jacobi preconditioning We want to solve (5) by an iterative Krylov subspace method like GMRES or QMR. An important factor in whether or not an iterative method is successful is the preconditioning technique. Typically it involves replacing the original system (5) by the equivalent system ATIZI = AFlU. (6) The transformed system has the same solution as the original system 21 = U, but the spectral properties of its coefficient matrix M-i2 may be more favorable, as they cause a better convergence rate than that of the original system. In devising a preconditioner, one has to find a matrix M that approximates Z in some sense, and can be much easier to solved than 2. The block Jacobi preconditioner will fulfill all these tasks. The block Jacobi preconditioner can be derived by partitioning of the variables. To do that the index set N = 1,..., n is partitioned as N = lji Ni with mutually disjoint subsets Ni. The elements of M are given by 77&j = Zij if i, j are in the same subset, 0 otherwise. From the block structure of the impedance matrix, a natural choice for the partitioning over the different physical domains is first, to order the unknowns in (5) according to the surfaces. Using this ordering scheme for the partitioning, one will get M=[! i $1. Second, the currents on Sa are also ordered by the volumes in which they radiate. If one now applies one more partitioning 2; 00 over the single volumes, the following preconditioner will result M= 0 Z,l Yz i 1 (7) Normally only one matrix-vector multiplication of a vector with M-l is needed within the iterative method. Instead of calculating Mm1 directly, it is advantageous to factorize M by an LU decomposition and then to perform a forward and backward substitution, provided M-l is applied to a vector. As the single blocks in M according to (7) are decoupled and can be factorized independently, an LU decomposition of M is very simple. Consequently the numerical effort for a decomposition of M is reduced substantially compared to the decomposition of 2. To interprete the numerical process physically, only that part of the impedance matrix, which describes the interaction of a structure part with itself, is used in the preconditioner. Such a preconditioner technique can often be applied successfully in the numerical treatment of differential equations with multiple physical domains. It will be demonstrated that this technique is also applicable for those structured matrices from the MOM. The described preconditioner technique can be expanded in a straight forward manner to configurations which contain more than two non-galvanically coupled substructures or configurations with many different physical domains (multizone scatterers). The efficiency increases with growing number of domains. The block Jacobi preconditioning method itself has the advantage of not requiring any additional storage, as the diagonal blocks are already existing in the impedance matrix, moreover they can be easily implemented and adopted for parallel computation. Matrix transformation methods Geometrically thin but electrically thick penetrable material layers (for instance radoms, plastic casings, vaporized metal coats etc.), which influence the radiation coupling, can often be found in technical configurations. If the field distribution inside a layer is not of interest and if the thickness of the layer is very small in comparison with the dimensions of the coated object, it is possible to consider the layer by generalized boundary conditions for a dielectric body. The treatment of shielding problems is an important application: the shielded space is considered to be a dielectric (air), of which the limited surface is covered by a shielding material (see shielded enclosure example below). In a previous work the possibility to consider the layer in a given equation ZI = U subsequently by transformations of the original impedance matrix 2 and the right hand side U has been shown (for details see [2]). These transformations combine the blocks in the impedance matrix in a certain way but prevent the separation of the currents over the surfaces and volumes, i.e. the partitioning of the variables is unchanged, only the elements of some blocks are modified. Proceeding from that it is possible to apply the preconditioner technique described above to the new equation system. E.g. if the surface 5 s of the dielectric body in Fig. 1 is coated, the subsequent transformations will alter (5) to z,l z? 0 1: Z,l - AY; Z; - AY; BY,2 -BY; -BY; Z; + AY; I[1 I; = 122 with A, B being diagonal matrices. The elements aii, bii of A and B depend on the material constants of the layer and the geometry of the coated body. The preconditioner matrix for this equation system will look as shown in the preceding subsection z,l 0 0 M= 0 Z;-AY,1 0 [ 0 0 Zz +AY,2 1 The executed transformations do generally not influence the quality of the preconditioner M. 238

4 FURTHER APPLICATION POSSIBILITIES Use of preconditioners in iterative methods naturally results in an additional numerical effort, as the preconditioner has to be prepared and applied within the iteration. The preparation phase is most expensive when applying the block Jacobi preconditioner, but it has been shown that the initial costs will pay off during the iterations. The initial costs are also justifiable, if the preconditioner can be used for multiple linear systems repeatedly, e.g. in steps of a frequency loop. Within these steps each time an equation system Z(f)l(f) = U(f) has to be set up and solved. If it is now possible to set up a preconditioner M that is independent of the frequency, its utilization is worthwhile even if its initial costs are very high. One possibility is to use the LU decomposition of the impedance matrix at the frequency fmin as a preconditioner for all other frequencies [6]. But the preconditioner loses its ability to approximate the impedance matrix with increasing distance from the starting frequency, which results in the necessity to more iterations, and the final overall effort (matrix-vector multiplication with impedance matrix and preconditioner) is hardly profitable compared to that of the LU decomposition. In this case an improvement can be gained by using a new LU decomposition at a higher frequency as a preconditioner for all further frequency steps. This process repeats itself when the quality of this last preconditioner becomes unacceptable, namely below a predefined fixed value. Consequently the iteration steps through the frequency domain of the above algorithm are the following: 0. Set f = fmin 1. Compute ZI = U at f 2. Do an LU decomp. of Z and set 111-l = Z-l 3. Increment f 4. While f < frnaz Compute ZI = U at f Solve equation system iteratively using M-l Increment f If no. of iterations exceeds limit goto 1 This algorithm is very suitable if the (not necessarily equidistant) step width is not too high, otherwise there is the probability that the preconditioner loses its quality already for the next frequency. If these requirements are fulfilled, the solving time in a frequency loop can be reduced significantly by this method (see example below). It should also be mentioned that variants of this algorithm can be applied at other parameter studies as well. It can be used for example to examine the effect of different layers of an antenna or the different conductivity for the same geometry. In the algorithm shown above the frequency then has to be adjusted for the respectively examined parameter. EXAMPLES The method was implemented in the field computation program CONCEPT [7] to demonstrate the efficiency of the preconditioner. This program uses a direct solver (a special version of the LU decomposition, which partly takes advantage of zero blocks in the impedance matrix) for solving the equation system. In the following, the arithmetic times of the direct method are compared to those of the iterative methods in conjunction with the preconditioning time. Model of a human head next to a handy Fields and specific absorption rates (SAR) expected in a human body when exposed to radiations produced by a cellular phone is investigated by means of a model. The model used is depicted in Fig. 2. The handy is modeled as a perfect electric conductor and the human model is made up of a dielectric body. The excitation is given by an antenna with power feed of 1 W at 900 MHz. The whole problem produces 2489 unknowns: 425 unknowns for the handy with antenna and 1032 unknowns each for the inner and outer currents of the dielectric. The model is (concerning its topology) equivalent to the one in Fig. 1 and therefore produces an equation system as in (5). Consequently the preconditioner M contains three diagonal blocks with 425, 1032 and 1032 unknowns and the initial cost in the set-up of the preconditioner is to solve these three decoupled matrix systems. On an IBM RS it takes s. The iterative solver (GMRES) requires 10 iterations to get an accurate solution (norm of residual is less then 10e4) in 12.4 s, so one gets a solution in s whereas the direct solver needs s for the LU decomposition of the impedance matrix. It can easily be seen that one has a speedup of 6.4 by this. Shielded enclosure The configuration according to Fig. 3 was the subject of another numerical investigation, The depicted model is placed in free space and consists of an outer completely closed shielded enclosure (2.5 m x 2 m x 4 m) containing much smaller cubes of edges 0.5 m. The internal cubes are bounded by highly conducting sheets and are connected by means of two wires. The walls of the chamber are formed by plane sheets of relatively lowconductive isotropic material ( S/m, et = 3.7) 1.3 mm thick. A special feature of the enclosure is that all edges consist of metal strips of 5 cm wide (also 1.3 mm thickness, high conductivity). A perfect connection between high and low conducting enclosure surface parts is assumed. This example makes use of the above-mentioned method in order to take into account the conducting walls of the shielded enclosure. The internal structure of the shielded enclosure is depicted as a dielectric (air) and the corresponding impedance matrix is set up. Afterwards the layers are considered by transformations with the separation of inner and outer currents being preserved. In contrary to the example above the currents are partitioned into four index sets: currents that flow on the inner 239

5 structure, the inner and outer currents of the shielded enclosure and the currents flowing on the metal strips at the edges of the chamber. Hence the impedance matrix with 5348 unknowns is transformed into four diagonal blocks. One of them has 600 unknowns (from internal structure), one has 300 unknowns (from metal strips), and two have 2224 unknowns (internal and external currents on the walls). These four diagonal blocks will be used as the preconditioner. The calculation of the preconditioner needs 1372 s, whereas the calculation of the iterative solver (GMRES) needs 15 iterations which were completed in 257.4s. The direct solver needs s and therefore one gets a speedup of 6.2. Frequency loop The following example will demonstrate the advantage of an iterative solver even when the initial costs of the preconditioner are very high: We have a model of a VW Golf with a top antenna (Fig. 4). The effect of the field will be investigated in a frequency range from 2 MHz up to 100 MHz with an equidistant step width of 2 MHz. Figure 2: Cellular phone next to a model of a human head Figure 4: Model of a VW Golf As described above, in the first place a LU decomposition of the impedance matrix (1789 unknowns) is calculated and used as a preconditioner for the following frequencies. When the number of iterations exceeds the limit of 10, a new decomposition is calculated for the next step and used as the new preconditioner, and so forth. Within these 50 iteration steps from 2 MHz to 100 MHz steps a new decomposition had to be calculated three times, as the number of iterations exceeded the limit of the previous step. The overall solution time amounted to 3155s. If the direct solver is used in each step, we get a solution time of s, meaning a speed-up gain of 5.5. CONCLUSION Figure 3: Completely closed chamber with low conducting walls and internal structure It has been shown that the iterative process can be used to solve the MOM system of equations, as far as an appropriate preconditioner exists. The block Jacobi preconditioner provides a very simple and efficient method. Different physical domains pro- 24.o

6 duce a block structure in the impedance matrix and the blocks used in the preconditioner have the same size as those in the impedance matrix. These classes of problems appear quite often in the area of EMC (see examples above). The efficiency of the process increases with the growing number of different domains. Even if there is only one domain, the iteration process can still somewhat reduce the solution time involved in the frequency loop. The initial costs of the preconditioner might involve factorization of possibly large amount of blocks during the setup phase. It should be attempted in the future to reduce the numerical effort required for preconditioners with big block sizes. An appropriate preconditioner should also be developed for systems where only one domain (e.g. one PEC structure) is present. Lastly, in order to deal with large scale problems more efficiently, the process should be further integrated with numerical methods that would reduce the amount of the computations for matrix-vector multiplications (e.g. the MLMDA). REFERENCES [l] R. Barrett, M. Berry, T. Chan, J. Demmel, J. Donato, J. Dongarra, V. Eijkhout, R. Pozo, Ch. Romine, and H.van der Vorst, Templates for the Solution of Linear Systems: Building Blocks for Iterative Methods, SIAM Publications, [2] G. Burger, H-D. Brtins, H. Singer, Simulation of thin layers in the method of moments, in Proc. of the 11th Int. Zurich Symp. on EMC, paper 64K3,1995. [3] EX. Canning, Improved impedance matrix localization method IEEE Trans. Antennas and Propagat., vol. 41, no. 5, pp , May [4] R. Coifman, V. Rohklin, and S. Wandzura, The fast multipole methods for the wave equation: A pedestrian prescription, IEEE Antennas and Propagat. Mag., vol. 35, pp. 7-12, June [5] R.F. Harrington, Field Computation by Moment Methods, New York: IEEE Press, reprint [6] G. Hoyler and R. Unbehauen, An efficient algorithm for the treatment of multiple frequencies with the method of moments, in Proc. of the Int. Symp. on Electromagnetic Compatibility EMC 96 Roma, paper J-3, [7] Th. Mader, Berechnung elektromagnetischer Felderscheinungen in abschnittsweise homogenen Medien mit Obeq%ichenstromsimulation, Doct. Thesis, TU Hamburg-Harburg, [8] E. Michielssen, and A. Boag, A multilevel matrix decomposition algorithm for analyzing scattering from large structures, IEEE Trans. Antennas and Propagat., vol. 44, no. 8, pp , Aug [9] T.K. Sarkar, K.R. Siarkiewicz, and R.F. Stratton, Survey of numerical methods for solution of large systems of linear equations for electromagnetic field problems, IEEE Trans. Antennas and Propagat., vol. 29, no. 6, pp , Nov

Evaluation of Iterative-Solutions used for Three-Dimensional Volume Integral Equation

Evaluation of Iterative-Solutions used for Three-Dimensional Volume Integral Equation Paper Evaluation of Iterative-Solutions used for Three-Dimensional Volume Integral Equation Non-member Yasuo Takahashi (Gifu University) Member Kazuo Tanaka (Gifu University) Non-member Masahiro Tanaka

More information

On the Interior Resonance Problem When Applying a Hybrid FEM/MoM Approach to Model Printed Circuit Boards

On the Interior Resonance Problem When Applying a Hybrid FEM/MoM Approach to Model Printed Circuit Boards 318 IEEE TRANSACTIONS ON ELECTROMAGNETIC COMPATIBILITY, VOL. 44, NO. 2, MAY 2002 On the Interior Resonance Problem When Applying a Hybrid FEM/MoM Approach to Model Printed Circuit Boards Yun Ji, Member,

More information

A Novel Approach for Solving the Power Flow Equations

A Novel Approach for Solving the Power Flow Equations Vol.1, Issue.2, pp-364-370 ISSN: 2249-6645 A Novel Approach for Solving the Power Flow Equations Anwesh Chowdary 1, Dr. G. MadhusudhanaRao 2 1 Dept.of.EEE, KL University-Guntur, Andhra Pradesh, INDIA 2

More information

Iterative methods for Linear System of Equations. Joint Advanced Student School (JASS-2009)

Iterative methods for Linear System of Equations. Joint Advanced Student School (JASS-2009) Iterative methods for Linear System of Equations Joint Advanced Student School (JASS-2009) Course #2: Numerical Simulation - from Models to Software Introduction In numerical simulation, Partial Differential

More information

OUTLINE 1. Introduction 1.1 Notation 1.2 Special matrices 2. Gaussian Elimination 2.1 Vector and matrix norms 2.2 Finite precision arithmetic 2.3 Fact

OUTLINE 1. Introduction 1.1 Notation 1.2 Special matrices 2. Gaussian Elimination 2.1 Vector and matrix norms 2.2 Finite precision arithmetic 2.3 Fact Computational Linear Algebra Course: (MATH: 6800, CSCI: 6800) Semester: Fall 1998 Instructors: { Joseph E. Flaherty, aherje@cs.rpi.edu { Franklin T. Luk, luk@cs.rpi.edu { Wesley Turner, turnerw@cs.rpi.edu

More information

Frequency Interpolation Methods for Accelerating Parallel EMC Analysis

Frequency Interpolation Methods for Accelerating Parallel EMC Analysis Frequency Interpolation Methods for Accelerating Parallel EMC Analysis K. Homma Secure Computing Laboratory, Computer System Laboratories, Fujitsu Laboratories Ltd homma@flab.fujitsu.co.jp K. Nagase Technology

More information

GEOMETRY BASED PRECONDITIONER FOR RADIA- TION PROBLEMS INVOLVING WIRE AND SURFACE BASIS FUNCTIONS

GEOMETRY BASED PRECONDITIONER FOR RADIA- TION PROBLEMS INVOLVING WIRE AND SURFACE BASIS FUNCTIONS Progress In Electromagnetics Research, PIER 93, 29 40, 2009 GEOMETRY BASED PRECONDITIONER FOR RADIA- TION PROBLEMS INVOLVING WIRE AND SURFACE BASIS FUNCTIONS M. G. Araújo, J. M. Bértolo, F. Obelleiro,

More information

Algorithm for Sparse Approximate Inverse Preconditioners in the Conjugate Gradient Method

Algorithm for Sparse Approximate Inverse Preconditioners in the Conjugate Gradient Method Algorithm for Sparse Approximate Inverse Preconditioners in the Conjugate Gradient Method Ilya B. Labutin A.A. Trofimuk Institute of Petroleum Geology and Geophysics SB RAS, 3, acad. Koptyug Ave., Novosibirsk

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

Finite Element Method (FEM)

Finite Element Method (FEM) Finite Element Method (FEM) The finite element method (FEM) is the oldest numerical technique applied to engineering problems. FEM itself is not rigorous, but when combined with integral equation techniques

More information

On the Modal Superposition Lying under the MoM Matrix Equations

On the Modal Superposition Lying under the MoM Matrix Equations 42 P. HAZDRA, P. HAMOUZ, ON THE MODAL SUPERPOSITION LYING UNDER THE MOM MATRIX EQUATIONS On the Modal Superposition Lying under the MoM Matrix Equations Pavel HAZDRA 1, Pavel HAMOUZ 1 Dept. of Electromagnetic

More information

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University of Minnesota 2 Department

More information

A Discontinuous Galerkin Augmented Electric Field Integral Equation (DG-AEFIE) for Low-Frequency Electromagnetic Scattering Analysis

A Discontinuous Galerkin Augmented Electric Field Integral Equation (DG-AEFIE) for Low-Frequency Electromagnetic Scattering Analysis Forum for Electromagnetic Research Methods and Application Technologies (FERMAT) A Discontinuous Galerkin Augmented Electric Field Integral Equation (DG-AEFIE) for Low-Frequency Electromagnetic Scattering

More information

Convergence property of IDR variant methods in the integral equation analysis of electromagnetic scattering problems

Convergence property of IDR variant methods in the integral equation analysis of electromagnetic scattering problems LETTER IEICE Electronics Express, Vol.11, No.9, 1 8 Convergence property of IDR variant methods in the integral equation analysis of electromagnetic scattering problems Hidetoshi Chiba a), Toru Fukasawa,

More information

Iterative methods for Linear System

Iterative methods for Linear System Iterative methods for Linear System JASS 2009 Student: Rishi Patil Advisor: Prof. Thomas Huckle Outline Basics: Matrices and their properties Eigenvalues, Condition Number Iterative Methods Direct and

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

Multigrid absolute value preconditioning

Multigrid absolute value preconditioning Multigrid absolute value preconditioning Eugene Vecharynski 1 Andrew Knyazev 2 (speaker) 1 Department of Computer Science and Engineering University of Minnesota 2 Department of Mathematical and Statistical

More information

How to Analyze the EMC of a Complete Server System?

How to Analyze the EMC of a Complete Server System? How to Analyze the EMC of a Complete Server System? Christian Schuster and Xiaomin Duan Institut für Hamburg, Germany Workshop on Hybrid Computational Electromagnetic Methods for EMC/EMI (WS10) EMC Europe,

More information

Incomplete LU Preconditioning and Error Compensation Strategies for Sparse Matrices

Incomplete LU Preconditioning and Error Compensation Strategies for Sparse Matrices Incomplete LU Preconditioning and Error Compensation Strategies for Sparse Matrices Eun-Joo Lee Department of Computer Science, East Stroudsburg University of Pennsylvania, 327 Science and Technology Center,

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

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

1 Conjugate gradients

1 Conjugate gradients Notes for 2016-11-18 1 Conjugate gradients We now turn to the method of conjugate gradients (CG), perhaps the best known of the Krylov subspace solvers. The CG iteration can be characterized as the iteration

More information

ELECTROMAGNETIC ENVIRONMENT GENERATED IN A TEM CELL FOR BIOLOGICAL DOSIMETRY APPLICATIONS

ELECTROMAGNETIC ENVIRONMENT GENERATED IN A TEM CELL FOR BIOLOGICAL DOSIMETRY APPLICATIONS ISEF 2007 XIII International Symposium on Electromagnetic Fields in Mechatronics, Electrical and Electronic Engineering Prague, Czech Republic, September 13-15, 2007 ELECTROMAGNETIC ENVIRONMENT GENERATED

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

More information

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition n page v Preface to the Second Edition Preface to the First Edition xiii xvii 1 Background in Linear Algebra 1 1.1 Matrices................................. 1 1.2 Square Matrices and Eigenvalues....................

More information

4.4 Microstrip dipole

4.4 Microstrip dipole 4.4 Microstrip dipole Basic theory Microstrip antennas are frequently used in today's wireless communication systems. Thanks to their low profile, they can be mounted to the walls of buildings, to the

More information

A Two-Scale Adaptive Integral Method

A Two-Scale Adaptive Integral Method A Two-Scale Adaptive Integral Method Ali Yilmaz Department of Electrical & Computer Engineering University of Texas at Austin IEEE APS International Symposium USC/URSI ational Radio Science Meeting San

More information

THE solution to electromagnetic wave interaction with material

THE solution to electromagnetic wave interaction with material IEEE TRANSACTIONS ON ANTENNAS AND PROPAGATION, VOL. 52, NO. 9, SEPTEMBER 2004 2277 Sparse Inverse Preconditioning of Multilevel Fast Multipole Algorithm for Hybrid Integral Equations in Electromagnetics

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

Calculation of RF-Interference from Coupled Shielded Hybrid Cables Utilizing Current Probe Measurements

Calculation of RF-Interference from Coupled Shielded Hybrid Cables Utilizing Current Probe Measurements Calculation of RF-Interference from Coupled Shielded Hybrid Cables Utilizing Current Probe Measurements Dr. Peter Hahne, Ingenieurbüro Dr. Peter Hahne Dr. Martin Aidam, Daimler AG, Andreas Ludwig, Daimler

More information

The solution of the discretized incompressible Navier-Stokes equations with iterative methods

The solution of the discretized incompressible Navier-Stokes equations with iterative methods The solution of the discretized incompressible Navier-Stokes equations with iterative methods Report 93-54 C. Vuik Technische Universiteit Delft Delft University of Technology Faculteit der Technische

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

M.A. Botchev. September 5, 2014

M.A. Botchev. September 5, 2014 Rome-Moscow school of Matrix Methods and Applied Linear Algebra 2014 A short introduction to Krylov subspaces for linear systems, matrix functions and inexact Newton methods. Plan and exercises. M.A. Botchev

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

SURFACE integral equations (SIE) are commonly used to

SURFACE integral equations (SIE) are commonly used to 176 IEEE TRANSACTIONS ON ANTENNAS AND PROPAGATION, VOL. 57, NO. 1, JANUARY 2009 Comparison of Integral-Equation Formulations for the Fast and Accurate Solution of Scattering Problems Involving Dielectric

More information

Chapter 7 Iterative Techniques in Matrix Algebra

Chapter 7 Iterative Techniques in Matrix Algebra Chapter 7 Iterative Techniques in Matrix Algebra Per-Olof Persson persson@berkeley.edu Department of Mathematics University of California, Berkeley Math 128B Numerical Analysis Vector Norms Definition

More information

Review: From problem to parallel algorithm

Review: From problem to parallel algorithm Review: From problem to parallel algorithm Mathematical formulations of interesting problems abound Poisson s equation Sources: Electrostatics, gravity, fluid flow, image processing (!) Numerical solution:

More information

6. Iterative Methods for Linear Systems. The stepwise approach to the solution...

6. Iterative Methods for Linear Systems. The stepwise approach to the solution... 6 Iterative Methods for Linear Systems The stepwise approach to the solution Miriam Mehl: 6 Iterative Methods for Linear Systems The stepwise approach to the solution, January 18, 2013 1 61 Large Sparse

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

Iterative Methods and Multigrid

Iterative Methods and Multigrid Iterative Methods and Multigrid Part 3: Preconditioning 2 Eric de Sturler Preconditioning The general idea behind preconditioning is that convergence of some method for the linear system Ax = b can be

More information

SSOR PRECONDITIONED INNER-OUTER FLEXIBLE GMRES METHOD FOR MLFMM ANALYSIS OF SCAT- TERING OF OPEN OBJECTS

SSOR PRECONDITIONED INNER-OUTER FLEXIBLE GMRES METHOD FOR MLFMM ANALYSIS OF SCAT- TERING OF OPEN OBJECTS Progress In Electromagnetics Research, PIER 89, 339 357, 29 SSOR PRECONDITIONED INNER-OUTER FLEXIBLE GMRES METHOD FOR MLFMM ANALYSIS OF SCAT- TERING OF OPEN OBJECTS D. Z. Ding, R. S. Chen, and Z. H. Fan

More information

Lab 1: Iterative Methods for Solving Linear Systems

Lab 1: Iterative Methods for Solving Linear Systems Lab 1: Iterative Methods for Solving Linear Systems January 22, 2017 Introduction Many real world applications require the solution to very large and sparse linear systems where direct methods such as

More information

Design of a Non-uniform High Impedance Surface for a Low Profile Antenna

Design of a Non-uniform High Impedance Surface for a Low Profile Antenna 352 Progress In Electromagnetics Research Symposium 2006, Cambridge, USA, March 26-29 Design of a Non-uniform High Impedance Surface for a Low Profile Antenna M. Hosseini 2, A. Pirhadi 1,2, and M. Hakkak

More information

NUMERICAL electromagnetic modeling (EM) has had a

NUMERICAL electromagnetic modeling (EM) has had a 304 IEEE TRANSACTIONS ON ELECTROMAGNETIC COMPATIBILITY, VOL. 39, NO. 4, NOVEMBER 1997 A Hybrid FEM/MOM Technique for Electromagnetic Scattering Radiation from Dielectric Objects with Attached Wires Mohammad

More information

Alternative correction equations in the Jacobi-Davidson method

Alternative correction equations in the Jacobi-Davidson method Chapter 2 Alternative correction equations in the Jacobi-Davidson method Menno Genseberger and Gerard Sleijpen Abstract The correction equation in the Jacobi-Davidson method is effective in a subspace

More information

Electromagnetic wave propagation. ELEC 041-Modeling and design of electromagnetic systems

Electromagnetic wave propagation. ELEC 041-Modeling and design of electromagnetic systems Electromagnetic wave propagation ELEC 041-Modeling and design of electromagnetic systems EM wave propagation In general, open problems with a computation domain extending (in theory) to infinity not bounded

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

Franek, Ondrej; Sørensen, Morten; Bonev, Ivan Bonev; Ebert, Hans; Pedersen, Gert F.

Franek, Ondrej; Sørensen, Morten; Bonev, Ivan Bonev; Ebert, Hans; Pedersen, Gert F. Downloaded from vbn.aau.dk on: januar 31, 2019 Aalborg Universitet Influence of Resonances on the Huygens Box Method Franek, Ondrej; Sørensen, Morten; Bonev, Ivan Bonev; Ebert, Hans; Pedersen, Gert F.

More information

The Co-Conical Field Generation System A 40 GHz Antenna Test Cell

The Co-Conical Field Generation System A 40 GHz Antenna Test Cell A 40 GHz Antenna Test Cell David R. Novotny and Robert T. Johnk RF Technology Division 325 Broadway Boulder, Colorado 80303-3328 http://www.boulder.nist.gov/div813/rffields/emc_emi/co_con.html An Effort

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 18 Outline

More information

Finite-choice algorithm optimization in Conjugate Gradients

Finite-choice algorithm optimization in Conjugate Gradients Finite-choice algorithm optimization in Conjugate Gradients Jack Dongarra and Victor Eijkhout January 2003 Abstract We present computational aspects of mathematically equivalent implementations of the

More information

Preconditioned Parallel Block Jacobi SVD Algorithm

Preconditioned Parallel Block Jacobi SVD Algorithm Parallel Numerics 5, 15-24 M. Vajteršic, R. Trobec, P. Zinterhof, A. Uhl (Eds.) Chapter 2: Matrix Algebra ISBN 961-633-67-8 Preconditioned Parallel Block Jacobi SVD Algorithm Gabriel Okša 1, Marián Vajteršic

More information

This is a repository copy of Effect of Loading on Field Uniformity : Energy Diffusion in Reverberant Environments.

This is a repository copy of Effect of Loading on Field Uniformity : Energy Diffusion in Reverberant Environments. This is a repository copy of Effect of Loading on Field Uniformity : Energy Diffusion in Reverberant Environments. White Rose Research Online URL for this paper: http://eprints.whiterose.ac.uk/114564/

More information

On the Preconditioning of the Block Tridiagonal Linear System of Equations

On the Preconditioning of the Block Tridiagonal Linear System of Equations On the Preconditioning of the Block Tridiagonal Linear System of Equations Davod Khojasteh Salkuyeh Department of Mathematics, University of Mohaghegh Ardabili, PO Box 179, Ardabil, Iran E-mail: khojaste@umaacir

More information

Computation of Electromagnetic Energy Absorption in the Human Body Tissues by High Frequency Structure Simulator

Computation of Electromagnetic Energy Absorption in the Human Body Tissues by High Frequency Structure Simulator Computation of Electromagnetic Energy Absorption in the Human... Computation of Electromagnetic Energy Absorption in the Human Body Tissues by High requency Structure Simulator Md. Selim Hossain 1 and

More information

9.1 Preconditioned Krylov Subspace Methods

9.1 Preconditioned Krylov Subspace Methods Chapter 9 PRECONDITIONING 9.1 Preconditioned Krylov Subspace Methods 9.2 Preconditioned Conjugate Gradient 9.3 Preconditioned Generalized Minimal Residual 9.4 Relaxation Method Preconditioners 9.5 Incomplete

More information

Research Article Electromagnetic Radiation from Arbitrarily Shaped Microstrip Antenna Using the Equivalent Dipole-Moment Method

Research Article Electromagnetic Radiation from Arbitrarily Shaped Microstrip Antenna Using the Equivalent Dipole-Moment Method Antennas and Propagation Volume 2012, Article ID 181235, 5 pages doi:10.1155/2012/181235 Research Article Electromagnetic Radiation from Arbitrarily Shaped Microstrip Antenna Using the Equivalent Dipole-Moment

More information

PRECONDITIONING IN THE PARALLEL BLOCK-JACOBI SVD ALGORITHM

PRECONDITIONING IN THE PARALLEL BLOCK-JACOBI SVD ALGORITHM Proceedings of ALGORITMY 25 pp. 22 211 PRECONDITIONING IN THE PARALLEL BLOCK-JACOBI SVD ALGORITHM GABRIEL OKŠA AND MARIÁN VAJTERŠIC Abstract. One way, how to speed up the computation of the singular value

More information

QBX and the DPIE for the Maxwell Equations

QBX and the DPIE for the Maxwell Equations University of Illinois @ Urbana-Champaign Fall 2017 - CS 598 APK The Goal For this project, the goals were to implement a model for the Python package pytential for tackling the Maxwell Equations for perfect

More information

Study of Specific Absorption Rate (SAR) in the human head by metamaterial attachment

Study of Specific Absorption Rate (SAR) in the human head by metamaterial attachment Study of Specific Absorption Rate (SAR) in the human head by metamaterial attachment M. T Islam 1a), M. R. I. Faruque 2b), and N. Misran 1,2c) 1 Institute of Space Science (ANGKASA), Universiti Kebangsaan

More information

Lecture 11: CMSC 878R/AMSC698R. Iterative Methods An introduction. Outline. Inverse, LU decomposition, Cholesky, SVD, etc.

Lecture 11: CMSC 878R/AMSC698R. Iterative Methods An introduction. Outline. Inverse, LU decomposition, Cholesky, SVD, etc. Lecture 11: CMSC 878R/AMSC698R Iterative Methods An introduction Outline Direct Solution of Linear Systems Inverse, LU decomposition, Cholesky, SVD, etc. Iterative methods for linear systems Why? Matrix

More information

A PRECONDITIONER FOR THE HELMHOLTZ EQUATION WITH PERFECTLY MATCHED LAYER

A PRECONDITIONER FOR THE HELMHOLTZ EQUATION WITH PERFECTLY MATCHED LAYER European Conference on Computational Fluid Dynamics ECCOMAS CFD 2006 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 2006 A PRECONDITIONER FOR THE HELMHOLTZ EQUATION WITH PERFECTLY

More information

High Performance Nonlinear Solvers

High Performance Nonlinear Solvers What is a nonlinear system? High Performance Nonlinear Solvers Michael McCourt Division Argonne National Laboratory IIT Meshfree Seminar September 19, 2011 Every nonlinear system of equations can be described

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

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

More information

FOR SOLVING COMBINED FIELD INTEGRAL EQUATION. OF ELECTROMAGNETIC SCATTERING y. J. M. Song and W. C. Chew. Electromagnetics Laboratory

FOR SOLVING COMBINED FIELD INTEGRAL EQUATION. OF ELECTROMAGNETIC SCATTERING y. J. M. Song and W. C. Chew. Electromagnetics Laboratory MULTILEVEL FAST MULTIPOLE ALGORITHM FOR SOLVING COMBINED FIELD INTEGRAL EQUATION OF ELECTROMAGNETIC SCATTERING y J. M. Song and W. C. Chew Electromagnetics Laboratory Department of Electrical and Computer

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

Iterative solution of dense linear systems arising from the electrostatic integral equation in MEG

Iterative solution of dense linear systems arising from the electrostatic integral equation in MEG INSTITUTE OF PHYSICSPUBLISHING Phys. Med. Biol. 47 (2002) 961 975 PHYSICS INMEDICINE AND BIOLOGY PII: S0031-9155(02)29872-3 Iterative solution of dense linear systems arising from the electrostatic integral

More information

Do You Trust Derivatives or Differences?

Do You Trust Derivatives or Differences? ARGONNE NATIONAL LABORATORY 9700 South Cass Avenue Argonne, Illinois 60439 Do You Trust Derivatives or Differences? Jorge J. Moré and Stefan M. Wild Mathematics and Computer Science Division Preprint ANL/MCS-P2067-0312

More information

Domain decomposition on different levels of the Jacobi-Davidson method

Domain decomposition on different levels of the Jacobi-Davidson method hapter 5 Domain decomposition on different levels of the Jacobi-Davidson method Abstract Most computational work of Jacobi-Davidson [46], an iterative method suitable for computing solutions of large dimensional

More information

FEM/FMBEM coupling for acoustic structure interaction and acoustic design sensitivity analysis with sound-absorbing materials

FEM/FMBEM coupling for acoustic structure interaction and acoustic design sensitivity analysis with sound-absorbing materials Boundary Elements and Other Mesh Reduction Methods XXXVIII 113 FEM/FMBEM coupling for acoustic structure interaction and acoustic design sensitivity analysis with sound-absorbing materials Y. M. Xu, H.

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

ITERATIVE PROJECTION METHODS FOR SPARSE LINEAR SYSTEMS AND EIGENPROBLEMS CHAPTER 1 : INTRODUCTION

ITERATIVE PROJECTION METHODS FOR SPARSE LINEAR SYSTEMS AND EIGENPROBLEMS CHAPTER 1 : INTRODUCTION ITERATIVE PROJECTION METHODS FOR SPARSE LINEAR SYSTEMS AND EIGENPROBLEMS CHAPTER 1 : INTRODUCTION Heinrich Voss voss@tu-harburg.de Hamburg University of Technology Institute of Numerical Simulation TUHH

More information

Lecture 17: Iterative Methods and Sparse Linear Algebra

Lecture 17: Iterative Methods and Sparse Linear Algebra Lecture 17: Iterative Methods and Sparse Linear Algebra David Bindel 25 Mar 2014 Logistics HW 3 extended to Wednesday after break HW 4 should come out Monday after break Still need project description

More information

Solving Large Nonlinear Sparse Systems

Solving Large Nonlinear Sparse Systems Solving Large Nonlinear Sparse Systems Fred W. Wubs and Jonas Thies Computational Mechanics & Numerical Mathematics University of Groningen, the Netherlands f.w.wubs@rug.nl Centre for Interdisciplinary

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

Power Absorption of Near Field of Elementary Radiators in Proximity of a Composite Layer

Power Absorption of Near Field of Elementary Radiators in Proximity of a Composite Layer Power Absorption of Near Field of Elementary Radiators in Proximity of a Composite Layer M. Y. Koledintseva, P. C. Ravva, J. Y. Huang, and J. L. Drewniak University of Missouri-Rolla, USA M. Sabirov, V.

More information

Transient radiation of a thin wire antenna buried in a dielectric half space

Transient radiation of a thin wire antenna buried in a dielectric half space Transient radiation of a thin wire antenna buried in a dielectric half space D. Poljak ', B. Jajac * & N.Kovai: ~Departmentof Electronics, 2Department ofelectrical Engineering, University of Split, Croatia

More information

Magnetic Force on a Moving Charge

Magnetic Force on a Moving Charge Magnetic Force on a Moving Charge Electric charges moving in a magnetic field experience a force due to the magnetic field. Given a charge Q moving with velocity u in a magnetic flux density B, the vector

More information

Stochastic collocation analysis of the transient current induced along the wire buried in a lossy medium

Stochastic collocation analysis of the transient current induced along the wire buried in a lossy medium Computational Methods and Experimental Measurements XVII 47 Stochastic collocation analysis of the transient current induced along the wire buried in a lossy medium S. Šesnić 1, S. Lalléchère, D. Poljak

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 34: Improving the Condition Number of the Interpolation Matrix Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

More information

Technique for the electric and magnetic parameter measurement of powdered materials

Technique for the electric and magnetic parameter measurement of powdered materials Computational Methods and Experimental Measurements XIV 41 Technique for the electric and magnetic parameter measurement of powdered materials R. Kubacki,. Nowosielski & R. Przesmycki Faculty of Electronics,

More information

Capacitance of Dielectric Coated Cylinder of Finite Axial Length and Truncated Cone Isolated in Free Space

Capacitance of Dielectric Coated Cylinder of Finite Axial Length and Truncated Cone Isolated in Free Space 394 IEEE TRANSACTIONS ON ELECTROMAGNETIC COMPATIBILITY, VOL. 44, NO., MAY Capacitance of Dielectric Coated Cylinder of Finite Axial Length and Truncated Cone Isolated in Free Space S. B. Chakrabarty, Sukhendu

More information

Linear Algebra Review

Linear Algebra Review Chapter 1 Linear Algebra Review It is assumed that you have had a course in linear algebra, and are familiar with matrix multiplication, eigenvectors, etc. I will review some of these terms here, but quite

More information

ANALYSIS OF COMPLEX ANTENNA AROUND ELEC- TRICALLY LARGE PLATFORM USING ITERATIVE VECTOR FIELDS AND UTD METHOD

ANALYSIS OF COMPLEX ANTENNA AROUND ELEC- TRICALLY LARGE PLATFORM USING ITERATIVE VECTOR FIELDS AND UTD METHOD Progress In Electromagnetics Research M, Vol. 1, 13 117, 29 ANALYSIS OF COMPLEX ANTENNA AROUND ELEC- TRICALLY LARGE PLATFORM USING ITERATIVE VECTOR FIELDS AND UTD METHOD Z. L. He, K. Huang, and C. H. Liang

More information

Efficient Evaluation of the Rokhlin Translator in Multilevel Fast Multipole Algorithm

Efficient Evaluation of the Rokhlin Translator in Multilevel Fast Multipole Algorithm Ilari Hänninen and Jukka Sarvas, Efficient evaluation of the Rokhlin translator in multilevel fast multipole algorithm, Helsinki University of Technology, Electromagnetics Laboratory Report Series, Report

More information

ADI-preconditioned FGMRES for solving large generalized Lyapunov equations - A case study

ADI-preconditioned FGMRES for solving large generalized Lyapunov equations - A case study -preconditioned for large - A case study Matthias Bollhöfer, André Eppler TU Braunschweig Institute Computational Mathematics Syrene-MOR Workshop, TU Hamburg October 30, 2008 2 / 20 Outline 1 2 Overview

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

More information

ROF for the Combined Field Integral Equation

ROF for the Combined Field Integral Equation Progress In Electromagnetics Research M, Vol. 58, 87 96, 2017 ROF for the Combined Field Integral Equation Hua-Long Sun 1, *,ChuangMingTong 1,QiLiu 2, and Gao Xiang Zou 1 Abstract This article proposes

More information

Iterative Methods for Solving A x = b

Iterative Methods for Solving A x = b Iterative Methods for Solving A x = b A good (free) online source for iterative methods for solving A x = b is given in the description of a set of iterative solvers called templates found at netlib: http

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

Multipole-Based Preconditioners for Sparse Linear Systems.

Multipole-Based Preconditioners for Sparse Linear Systems. Multipole-Based Preconditioners for Sparse Linear Systems. Ananth Grama Purdue University. Supported by the National Science Foundation. Overview Summary of Contributions Generalized Stokes Problem Solenoidal

More information

On the modified conjugate gradient method in cloth simulation

On the modified conjugate gradient method in cloth simulation The Visual Computer manuscript No. (will be inserted by the editor) On the modified conjugate gradient method in cloth simulation Uri M. Ascher 1, Eddy Boxerman 2 Department of Computer Science, University

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

EXAMPLES OF CLASSICAL ITERATIVE METHODS

EXAMPLES OF CLASSICAL ITERATIVE METHODS EXAMPLES OF CLASSICAL ITERATIVE METHODS In these lecture notes we revisit a few classical fixpoint iterations for the solution of the linear systems of equations. We focus on the algebraic and algorithmic

More information

EINDHOVEN UNIVERSITY OF TECHNOLOGY Department ofmathematics and Computing Science

EINDHOVEN UNIVERSITY OF TECHNOLOGY Department ofmathematics and Computing Science EINDHOVEN UNIVERSITY OF TECHNOLOGY Department ofmathematics and Computing Science RANA03-15 July 2003 The application of preconditioned Jacobi-Davidson methods in pole-zero analysis by J. Rommes, C.W.

More information

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Marcella Bonazzoli 2, Victorita Dolean 1,4, Ivan G. Graham 3, Euan A. Spence 3, Pierre-Henri Tournier

More information

USAGE OF NUMERICAL METHODS FOR ELECTROMAGNETIC SHIELDS OPTIMIZATION

USAGE OF NUMERICAL METHODS FOR ELECTROMAGNETIC SHIELDS OPTIMIZATION October 4-6, 2007 - Chiinu, Rep.Moldova USAGE OF NUMERICAL METHODS FOR ELECTROMAGNETIC SHIELDS OPTIMIZATION Ionu- P. NICA, Valeriu Gh. DAVID, /tefan URSACHE Gh. Asachi Technical University Iai, Faculty

More information

WHEN studying distributed simulations of power systems,

WHEN studying distributed simulations of power systems, 1096 IEEE TRANSACTIONS ON POWER SYSTEMS, VOL 21, NO 3, AUGUST 2006 A Jacobian-Free Newton-GMRES(m) Method with Adaptive Preconditioner and Its Application for Power Flow Calculations Ying Chen and Chen

More information

Stable Implicit Scheme for TM Transient Scattering from 2D Conducting Objects Using TD-EFIE

Stable Implicit Scheme for TM Transient Scattering from 2D Conducting Objects Using TD-EFIE Progress In Electromagnetics Research Letters, Vol. 73, 99 104, 2018 Stable Implicit Scheme for TM Transient Scattering from 2D Conducting Objects Using TD-EFIE Qiang Wang 1, 2, Lixin Guo 1, *,PengjuYang

More information