Multi-source inversion of TEM data: with field applications to Mt. Milligan

Size: px
Start display at page:

Download "Multi-source inversion of TEM data: with field applications to Mt. Milligan"

Transcription

1 Multi-source inversion of TEM data: with field applications to Mt. Milligan D. Oldenburg, E. Haber, D. Yang Geophysical Inversion Facility, University of British Columbia, Vancouver, BC, Canada Summary We present a practical formulation for forward modeling and inverting time domain data arising from multiple transmitters. The underpinning of our procedure is the ability to factor the forward modeling matrix and then solve our system using direct methods. We first formulate Maxwell s equations in terms of the magnetic field, H to provide a symmetric forward modeling operator. The problem is discretized using a finite volume technique in space and a backward Euler in time. The MUMPS software package is used to carry out a Cholesky decomposition of the forward operator, with the work distributed over an array of processors. The forward modeling is then quickly carried out using the factored operator. The time savings are considerable and they make the simulations of large ground or airborne data sets feasible and greatly increase our ability to solve the 3D electromagnetic inverse problem in a reasonable time. We illustrate the capability, and need, for 3D inversion by inverting airborne VTEM data from Mt. Milligan, a Cu-Au porphyry deposit in British Columbia. Introduction In previous research (Haber, Oldenburg, & Shekhtman, 2007) we developed an inversion algorithm that allowed us to invert data from a single, or a very few, transmitters. Unfortunately the computational demands of that algorithm were too large to invert typical ground or airborne surveys acquired from many source locations. The principal difficulty is the time required to solve the forward problem. Simulating data that arise from multi-sources can be computationally onerous because each transmitter requires that Maxwell s equations be solved. Usually this is done with iterative (eg. CGtype) algorithms and hence the computation time increases linearly with the number of transmitter locations. However, for surveys with a large number of sources, significant increases in efficiency can be had if the forward modeling matrix is factored. Factorization involves large computations and significant memory requirements. However, once this is accomplished, solving the factored system with a different right hand side proceeds very quickly. The idea of decomposing the matrix system and solving many right hand sides for different sources is not new (Dey & Morrison, 979), and small problems have been solved in this manner. However, the matrices for 3D TEM problems have generally been considered to be too large to contemplate this approach. Over the last decade however, advances in mathematics and computing science have resulted in factorization algorithms that can be implemented on large scale computing systems (Amestoy, Guermouche, LExcellent, & Pralet, 2006). The efficacy of this approach depends upon the time required to factor the matrix compared to the time required to solve the matrix system using iterative solvers. We use the MUMPS codes and distribute the computation over many different processors. We have shown preliminary results about the use of the decomposition method and inversion in a previous presentation (SEG 2008). Here we extend that analysis and apply it to field data. Maxwell s Equations in the Time Domain We first write the discrete form of Maxwell s equations. Using a backward Euler discretization in time with step size we obtain Hi+ Hi E i+ + μ = 0, () EGM 200 International Workshop Capri, Italy, April -4, 200

2 Ei+ Ei Hi+ σe i+ ε = si. (2) δ t E i and H i are the electric and magnetic fields that correspond to the source s i, μ is the permeability, σ is the conductivity, ε is the permittivity and s is a source. Eliminating the electric field E i+ from Maxwell s equations, we obtain an equation for the magnetic field H i+ μ ( σ + ε) Hi+ + Hi+ = rh s i + (3) The above system can be near-singular when the conductivity is small and the time steps are large. To stabilize it, we recall that we also have μh = 0 and therefore we can rewrite the system as μ ( σ + ε) Hi+ μ ( σ + ε) ( μh i+ ) + Hi+ = rhsi+ (4) Upon discretization in space, we obtain the linear system A( σ ) H : = ( C( σδ, t) + M) H = rhs i+ i+ where the matrix C( σ, δ t) is a discretization of the differential operator in (5). The matrix is SPD and depends on the conductivity and the time step. The matrix M depends on μ and. We note that by using the same time steps, the linear system (5) is identical for all times and all sources. Matrix factorization is an expensive computational process, however, when the same forward modeling matrix needs to be solved for many times and sources, the decomposition will be greatly superior to iterative techniques. The benefits of this are exacerbated when one proceeds to the inverse problem since the same factorization can be used for the computation of the gradient as well as for the solution of the linear system which arises at each Gauss-Newton iteration. In recent years there has been a growing effort to obtain scalable matrix factorizations on parallel machines. We use the package Multi-frontal Massively Parallel Solver (MUMPS) by the CERFACS group (Amestoy et al., 2006). MUMPS is a package for solving systems of linear equations of the form Ax = b, where the matrix A is sparse and can be either unsymmetric, symmetric positive definite, or general symmetric. Implementation of the Forward Modeling To obtain insight regarding the implementation of the decomposition we consider a representative time domain airborne survey using the VTEM system. The transmitter is a horizontal circular loop, of 26 meters diameter, flown at 50 meters elevation. Data, db/dt, are acquired in the center of the loop. The ideal waveform for this system is shown in Figure. Data are acquired in 27 time channels, equispaced in logarithmic time between 0-5 and 0-2 seconds after the turnoff time. Our equations are to be time stepped so that we capture the input waveform during the on-time and also capture the logarithmically spaced times after the turnoff (off-time). Also, we need to begin our time stepping a decade earlier than the first time channel and hence a = seconds is required. Unfortunately, we can t use that step for the entire interval since it would then require 0 4 time steps and the cumulative time for all of these solves is approximately 6 seconds hours. This difficulty can be circumvented by dividing our total time interval into subintervals, each of which has a constant. One additional factorization is required for each subinterval. The off-time part here can be solved using 3 factorizations and 58 time steps. The segments which are subsequently uniformly time-stepped are shown in Figure b. Each segment is divided into 5 ~ 25 steps and hence the total number of time steps and the total number of factorizations for a complete waveform are 88 and 5 respectively. With the factored system the time required to solve a forward problem, t s, is 6 seconds for this example. The total number of forward solutions is equal to (5) EGM 200 International Workshop Capri, Italy, April -4, 200

3 N TX, where is the number of transmitters. Thus the total time taken to solve our problem N δ t N TX is T = N N t + t where tf is the time carrying out a factorization. total TX δ t s f (a) on-time discretized waveform (b) off-time waveform and time channels Figure. Transmitter current waveform of VTEM system Inversion The real benefit of using decomposition in our forward modeling becomes apparent when we treat the inverse problem. Our inversion algorithm (Haber et al., 2007), is based upon a Gauss-Newton procedure where a model m = lnσ is sought. The forward modeling is generically written as A(m)u = q where A is the forward modeling matrix, u are the fields, and q is the right hand side which contains the source terms. At every Gauss-Newton iteration, the equation ( ( ) T T Jm Jm ( ) + βwws ) = gm ( ) (8) is solved to obtain a perturbation s from a current model m. W is a sparse regularization matrix, β is a constant, and g(m) is the gradient of the objective function. The sensitivity matrix is available as J(m) = -QA(m) - G(m,u), where Q is an interpolation matrix that extracts the simulated data from the computed fields and G(m,u) is a known sparse matrix ( A( mu ) ) G( m, u) = (9) m We note that G requires the fields for all transmitters and for all times. These have been computed to evaluate the misfit and gradient, but they need to be stored or recomputed to carry out the effect of multiplying J or J T on a vector. Field Example Mt. Milligan is a Cu-Au porphyry deposit in central British Columbia and it has served as a test site for the inversion of many different types of geophysical surveys (Oldenburg et al., 997). The basic geologic and petrophysical structure consists of a resistive monzonite stock surrounded by a conductive alteration zone. The host rock is volcanic (Figure 2a). The area is covered with a variable thickness, moderately conductive overburden. EGM 200 International Workshop Capri, Italy, April -4, 200

4 (a) geologic model at Mt. Milligan (b) D inversion of VTEM data Figure 2. Comparison between geologic model and D inversion VTEM data were acquired along several lines in the area and a D inversion was carried out. One conductivity cross section of our D inversion is shown in Figure 2b. We note that soundings directly over the resistive stock (horizontal coordinate is ) indicate a conductive layer at depth which is contrary to the expected result. To test the hypothesis that the conductive layer was an artifact of using a D inversion model we selected a small subset of the airborne data and carried out a 3D inversion using only the 28 transmitter locations shown on the map in Figure 3a. (a) locations of soundings for 3D inversion (b) cross section of 3D inversion model Figure 3. 3D inversion with 28 VTEM soundings at Mt. Milligan In our 3D inversion, the model domain was discretized by a mesh (20, 000 cells), in which the finest cells are with a dimension of meters. The inversion was carried out on 3 dual quadcore machines. The initial and reference models were set to 500Ωm. After 2 iterations, the inversion achieved a data misfit equivalent to chifact =.6. One cross section of the 3D inversion model, shown in Figure 3b, highlights a massive resistive rock unit corresponding to the drillholeproven monzonite stock. This coincides spatially whered inversion found relatively conductive material. Conclusions We have demonstrated the benefits of solving multi-source time domain electromagnetic problems by decomposing the matrix and using direct solvers. This methodology has been proven efficient and practical from the computational point of view if the transmitter waveform and mesh are appropriately designed. Our field data example of VTEM at Mt. Milligan showcases the advantage of 3D multisource inversion over D inversion in revealing complicated geologic structure. References Amestoy, P.R., Guermouche, A., L Excellent, J.-Y., Pralet, S Hybrid scheduling for the parallel solution of linear systems. Parallel Computing, 32, Dey, A., Morrison, H.F.979. Resistivity modeling for arbitrarily shaped three-dimensional structures. Geophysics, 44, EGM 200 International Workshop Capri, Italy, April -4, 200

5 Haber, E., Oldenburg, D., & Shekhtman, R Inversion of time domain 3D electromagnetic data. Geoph. J. Int., 7, Oldenburg, D., Li, Y., Ellis, R Inversion of geophysical data over a copper gold porphyry deposit: A case history for Mt. Milligan. Geophysics, 62, Oldenburg, D., Haber, E., Shekhtman, R., Forward modeling and inversion of multi-source TEM data. SEG Annual Meeting, Las Vegas. EGM 200 International Workshop Capri, Italy, April -4, 200

Downloaded 01/09/13 to Redistribution subject to SEG license or copyright; see Terms of Use at

Downloaded 01/09/13 to Redistribution subject to SEG license or copyright; see Terms of Use at 3D modeling of IP effects on electromagnetic data in the time domain David Marchant, Eldad Haber, Laurens Beran and Douglas W. Oldenburg, University of British Columbia Downloaded /9/3 to 37.82.7.. Redistribution

More information

Parallelizing large scale time domain electromagnetic inverse problem

Parallelizing large scale time domain electromagnetic inverse problem Parallelizing large scale time domain electromagnetic inverse problems Eldad Haber with: D. Oldenburg & R. Shekhtman + Emory University, Atlanta, GA + The University of British Columbia, Vancouver, BC,

More information

Downloaded 01/09/13 to Redistribution subject to SEG license or copyright; see Terms of Use at

Downloaded 01/09/13 to Redistribution subject to SEG license or copyright; see Terms of Use at Three-dimensional inversion of SQUID TEM data at Lalor Lake VMS deposit Dikun Yang*, Douglas W. Oldenburg Geophysical Inversion Facility, Earth and Ocean Sciences, University of British Columbia Summary

More information

SUMMARY METHODOLOGY. 1 + (1 η)(ıωτ) c

SUMMARY METHODOLOGY. 1 + (1 η)(ıωτ) c On recovering induced polarization information from airborne time domain EM data Seogi Kang, Douglas W. Oldenburg, Dikun Yang, David Marchant, Geophysical Inversion Facility, University of British Columbia

More information

Downloaded 11/05/14 to Redistribution subject to SEG license or copyright; see Terms of Use at

Downloaded 11/05/14 to Redistribution subject to SEG license or copyright; see Terms of Use at Recovering a thin dipping conductor with 3D electromagnetic inversion over the Caber deposit Michael S. McMillan, Christoph Schwarzbach, Douglas W. Oldenburg and Eldad Haber, Geophysical Inversion Facility,

More information

Three-dimensional inversion of airborne time-domain electromagnetic data with applications to a porphyry deposit

Three-dimensional inversion of airborne time-domain electromagnetic data with applications to a porphyry deposit GEOPHYSICS, VOL. 77, NO. 2 (MARCH-APRIL 2012); P. B23 B34, 21 FIGS., 3 TABLES. 10.1190/GEO2011-0194.1 Case History Three-dimensional inversion of airborne time-domain electromagnetic data with applications

More information

Main Menu. Douglas Oldenburg University of British Columbia Vancouver, BC, Canada

Main Menu. Douglas Oldenburg University of British Columbia Vancouver, BC, Canada Using ERA low frequency E-field profiling and UBC 3D frequency-domain inversion to delineate and discover a mineralized zone in Porcupine district, Ontario, Canada. Vlad Kaminski* University of British

More information

Achieving depth resolution with gradient array survey data through transient electromagnetic inversion

Achieving depth resolution with gradient array survey data through transient electromagnetic inversion Achieving depth resolution with gradient array survey data through transient electromagnetic inversion Downloaded /1/17 to 128.189.118.. Redistribution subject to SEG license or copyright; see Terms of

More information

Modelling IP effects in airborne time domain electromagnetics

Modelling IP effects in airborne time domain electromagnetics Modelling IP effects in airborne time domain electromagnetics Dave Marchant* Seogi Kang Mike McMillian Eldad Haber Computational Geosciences University of British Columbia Computational Geosciences University

More information

Optimizing Geophysical Inversions for Archean Orogenic Gold Settings

Optimizing Geophysical Inversions for Archean Orogenic Gold Settings Geophysical Inversion and Modeling Optimizing Geophysical Inversions for Archean Orogenic Gold Settings 1. University of British Columbia Paper 103 Mitchinson, D. E. [1], Phillips, N. D. [1] ABSTRACT Geophysical

More information

Resource Management through Machine Learning

Resource Management through Machine Learning Resource Management through Machine Learning Justin Granek Eldad Haber* Elliot Holtham University of British Columbia University of British Columbia NEXT Exploration Inc Vancouver, BC V6T 1Z4 Vancouver,

More information

Inductive source induced polarization David Marchant, Eldad Haber and Douglas W. Oldenburg, University of British Columbia

Inductive source induced polarization David Marchant, Eldad Haber and Douglas W. Oldenburg, University of British Columbia David Marchant, Eldad Haber and Douglas W. Oldenburg, University of British Columbia Downloaded /9/3 to 37.8.7.. Redistribution subject to SEG license or copyright; see Terms of Use at http://library.seg.org/

More information

Airborne Inductive Induced Polarization Chargeability Mapping of VTEM Data

Airborne Inductive Induced Polarization Chargeability Mapping of VTEM Data Airborne Inductive Induced Polarization Chargeability Mapping of VTEM Data Karl Kwan Alexander Prikhodko Jean M. Legault* Geotech Ltd Geotech Ltd Geotech Ltd 245 Industrial Parkway N. 245 Industrial Parkway

More information

A Nested Dissection Parallel Direct Solver. for Simulations of 3D DC/AC Resistivity. Measurements. Maciej Paszyński (1,2)

A Nested Dissection Parallel Direct Solver. for Simulations of 3D DC/AC Resistivity. Measurements. Maciej Paszyński (1,2) A Nested Dissection Parallel Direct Solver for Simulations of 3D DC/AC Resistivity Measurements Maciej Paszyński (1,2) David Pardo (2), Carlos Torres-Verdín (2) (1) Department of Computer Science, AGH

More information

Summary. 3D potential field migration. Various approximations of the Newton method result in the imaging condition for the vector of densities, :

Summary. 3D potential field migration. Various approximations of the Newton method result in the imaging condition for the vector of densities, : 24 A case study from Broken Hill, Australia, with comparison to 3D regularized inversion Michael S. Zhdanov, University of Utah and TechnoImaging, Xiaojun Liu, University of Utah, Le Wan*, Martin Čuma,

More information

A parallel method for large scale time domain electromagnetic inverse problems

A parallel method for large scale time domain electromagnetic inverse problems A parallel method for large scale time domain electromagnetic inverse problems Eldad Haber July 15, 2005 Abstract In this work we consider the solution of 3D time domain electromagnetic inverse problems

More information

A New Direction. Copper-Gold Deposit at Thor TSX.V:COL. August 11, May 2013

A New Direction. Copper-Gold Deposit at Thor TSX.V:COL. August 11, May 2013 A New Direction Copper-Gold Deposit at Thor August 11, 2016 May 2013 TSX.V:COL FORWARD LOOKING STATEMENTS This presentation includes certain forward-looking information or forward-looking statements for

More information

Estimation of Cole-Cole parameters from time-domain electromagnetic data Laurens Beran and Douglas Oldenburg, University of British Columbia.

Estimation of Cole-Cole parameters from time-domain electromagnetic data Laurens Beran and Douglas Oldenburg, University of British Columbia. Estimation of Cole-Cole parameters from time-domain electromagnetic data Laurens Beran and Douglas Oldenburg, University of British Columbia. SUMMARY We present algorithms for the inversion of time-domain

More information

Lithology-based model transform. Summary

Lithology-based model transform. Summary cdf( ) pdf( ) 3D lithological inversion of geophysical data Leif H. Cox*, Glenn A. Wilson, TechnoImaging, Michael S. Zhdanov, University of Utah and TechnoImaging, and Julian Vrbancich, Defense Science

More information

From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D

From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D Luc Giraud N7-IRIT, Toulouse MUMPS Day October 24, 2006, ENS-INRIA, Lyon, France Outline 1 General Framework 2 The direct

More information

Two-dimensional Inversion of Resistivity and IP Data with Topography

Two-dimensional Inversion of Resistivity and IP Data with Topography Two-dimensional Inversion of Resistivity and IP Data with Topography a) Smooth-Model Resistivity (ohm-m) Elevation (m) b) Calculated Apparent Resistivity (ohm-m) 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9

More information

News Release No GOLD AND COPPER MINERALIZATION DISCOVERED DURING PHASE 2 EXPLORATION AT THE MCBRIDE PROPERTY

News Release No GOLD AND COPPER MINERALIZATION DISCOVERED DURING PHASE 2 EXPLORATION AT THE MCBRIDE PROPERTY November 19, 2018 TSX Venture Exchange Listed Frankfurt Exchange Listed News Release No. 303-2018 GOLD AND COPPER MINERALIZATION DISCOVERED DURING PHASE 2 EXPLORATION AT THE MCBRIDE PROPERTY Vancouver,

More information

A multigrid method for large scale inverse problems

A multigrid method for large scale inverse problems A multigrid method for large scale inverse problems Eldad Haber Dept. of Computer Science, Dept. of Earth and Ocean Science University of British Columbia haber@cs.ubc.ca July 4, 2003 E.Haber: Multigrid

More information

UBC-GIF: Capabilities for EM Modelling and Inversion of LSBB data

UBC-GIF: Capabilities for EM Modelling and Inversion of LSBB data The University of British Colubia Geophysical Inversion Facility slide 1 UBC-GIF: Capabilities for EM Modelling and Inversion of LSBB data Douglas W. Oldenburg Departent of Earth and Ocean Sciences June

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

Inversion of AEM data at a survey scale utilising new inversion solver and forward model

Inversion of AEM data at a survey scale utilising new inversion solver and forward model Inversion of AEM data at a survey scale utilising new inversion solver and forward model Jovan Silic (), Rod Paterson (Intrepid Geophysics), Des FitzGerald (Intrepid Geophysics), Outline: Describe the

More information

5.7 Cramer's Rule 1. Using Determinants to Solve Systems Assumes the system of two equations in two unknowns

5.7 Cramer's Rule 1. Using Determinants to Solve Systems Assumes the system of two equations in two unknowns 5.7 Cramer's Rule 1. Using Determinants to Solve Systems Assumes the system of two equations in two unknowns (1) possesses the solution and provided that.. The numerators and denominators are recognized

More information

Paradigm change in 3D inversion of airborne EM surveys: case study for oil sands exploration near Fort McMurray, Alberta

Paradigm change in 3D inversion of airborne EM surveys: case study for oil sands exploration near Fort McMurray, Alberta Paradigm change in 3D inversion of airborne EM surveys: case study for oil sands exploration near Fort McMurray, Alberta Michael S. Zhdanov, 1,2* Leif Cox, 1 and Jonathan Rudd 3 demonstrate with a case

More information

Anisotropic 2.5D Inversion of Towed Streamer EM Data from Three North Sea Fields Using Parallel Adaptive Finite Elements

Anisotropic 2.5D Inversion of Towed Streamer EM Data from Three North Sea Fields Using Parallel Adaptive Finite Elements Anisotropic 2.5D Inversion of Towed Streamer EM Data from Three North Sea Fields Using Parallel Adaptive Finite Elements K. Key (Scripps Institution of Oceanography), Z. Du* (PGS), J. Mattsson (PGS), A.

More information

Where does the proppant go? Examining the application of electromagnetic methods for hydraulic fracture characterization

Where does the proppant go? Examining the application of electromagnetic methods for hydraulic fracture characterization Where does the proppant go? Examining the application of electromagnetic methods for hydraulic fracture characterization Lindsey J. Heagy and Douglas W. Oldenburg Geophysical Inversion Facility, University

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT -09 Computational and Sensitivity Aspects of Eigenvalue-Based Methods for the Large-Scale Trust-Region Subproblem Marielba Rojas, Bjørn H. Fotland, and Trond Steihaug

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

Advanced processing and inversion of two AEM datasets for 3D geological modelling: the case study of Spiritwood Valley Aquifer

Advanced processing and inversion of two AEM datasets for 3D geological modelling: the case study of Spiritwood Valley Aquifer Advanced processing and inversion of two AEM datasets for 3D geological modelling: the case study of Spiritwood Valley Aquifer Vincenzo Sapia, INGV, Rome, Italy Vincenzo.sapia@ingv.it Andrea Viezzoli,

More information

Hamed Aber 1 : Islamic Azad University, Science and Research branch, Tehran, Iran. Mir Sattar Meshin chi asl 2 :

Hamed Aber 1 : Islamic Azad University, Science and Research branch, Tehran, Iran. Mir Sattar Meshin chi asl 2 : Present a Proper Pattern for Choose Best Electrode Array Based on Geological Structure Investigating in Geoelectrical Tomography, in order to Get the Highest Resolution Image of the Subsurface Hamed Aber

More information

Anna Avdeeva Dmitry Avdeev and Marion Jegen. 31 March Introduction to 3D MT inversion code x3di

Anna Avdeeva Dmitry Avdeev and Marion Jegen. 31 March Introduction to 3D MT inversion code x3di Anna Avdeeva (aavdeeva@ifm-geomar.de), Dmitry Avdeev and Marion Jegen 31 March 211 Outline 1 Essential Parts of 3D MT Inversion Code 2 Salt Dome Overhang Study with 3 Outline 1 Essential Parts of 3D MT

More information

Novel approach to joint 3D inversion of EM and potential field data using Gramian constraints

Novel approach to joint 3D inversion of EM and potential field data using Gramian constraints first break volume 34, April 2016 special topic Novel approach to joint 3D inversion of EM and potential field data using Gramian constraints Michael S. Zhdanov 1,2, Yue Zhu 2, Masashi Endo 1 and Yuri

More information

Tu Efficient 3D MT Inversion Using Finite-difference Time-domain Modelling

Tu Efficient 3D MT Inversion Using Finite-difference Time-domain Modelling Tu 11 16 Efficient 3D MT Inversion Using Finite-difference Time-domain Modelling S. de la Kethulle de Ryhove* (Electromagnetic Geoservices ASA), J.P. Morten (Electromagnetic Geoservices ASA) & K. Kumar

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

Prospectors Making NEW Discoveries

Prospectors Making NEW Discoveries Prospectors Making NEW Discoveries Hans Smit Minerals North 2012 Burns Lake, British Columbia May 2012 BC Needs New Discoveries BC mines and most advanced mineral projects were found decades ago To ensure

More information

Practical Linear Algebra: A Geometry Toolbox

Practical Linear Algebra: A Geometry Toolbox Practical Linear Algebra: A Geometry Toolbox Third edition Chapter 12: Gauss for Linear Systems Gerald Farin & Dianne Hansford CRC Press, Taylor & Francis Group, An A K Peters Book www.farinhansford.com/books/pla

More information

Simultaneous estimation of wavefields & medium parameters

Simultaneous estimation of wavefields & medium parameters Simultaneous estimation of wavefields & medium parameters reduced-space versus full-space waveform inversion Bas Peters, Felix J. Herrmann Workshop W- 2, The limit of FWI in subsurface parameter recovery.

More information

Revised Simplex Method

Revised Simplex Method 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

Kiska Metals Corporation Project Updates

Kiska Metals Corporation Project Updates Kiska Metals Corporation Project Updates Minerals North Conference, Mackenzie BC May 28, 2015 Kelly Franz, P.Geo Manager, Lands and Corporate Social Responsibility Cautionary Note This presentation contains

More information

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

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

More information

Comparison between least-squares reverse time migration and full-waveform inversion

Comparison between least-squares reverse time migration and full-waveform inversion Comparison between least-squares reverse time migration and full-waveform inversion Lei Yang, Daniel O. Trad and Wenyong Pan Summary The inverse problem in exploration geophysics usually consists of two

More information

Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras

Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras Module No. # 05 Lecture No. # 24 Gauss-Jordan method L U decomposition method

More information

Keywords. CSEM, Inversion, Resistivity, Kutei Basin, Makassar Strait

Keywords. CSEM, Inversion, Resistivity, Kutei Basin, Makassar Strait Noor Jehan Ashaari Muhamad* (EMGS Asia Pacific), Ritesh Mohan Joshi (EMGS Asia Pacific), Muhamad Afifie Chan Mahadie Chan (EMGS Asia Pacific) mmuhamad@emgs.com Keywords CSEM, Inversion, Resistivity, Kutei

More information

Pseudo-seismic wavelet transformation of transient electromagnetic response in engineering geology exploration

Pseudo-seismic wavelet transformation of transient electromagnetic response in engineering geology exploration GEOPHYSICAL RESEARCH LETTERS, VOL. 34, L645, doi:.29/27gl36, 27 Pseudo-seismic wavelet transformation of transient electromagnetic response in engineering geology exploration G. Q. Xue, Y. J. Yan, 2 and

More information

September 16, 2010 Magnetic surveying

September 16, 2010 Magnetic surveying September 16, 2010 Magnetic surveying After today, you will be able to Sketch anomalies over objects at any location, and explain how you derived the pattern. Explain the relation between dipoles and real

More information

Geophysical Journal International

Geophysical Journal International Geophysical Journal International Geophys. J. Int. (2010) 182, 168 182 doi: 10.1111/j.1365-246X.2010.04634.x GJI Geomagnetism, rock magnetism and palaeomagnetism Three-dimensional inversion of ZTEM data

More information

Applications of geophysical inversions in mineral exploration

Applications of geophysical inversions in mineral exploration Applications of geophysical inversions in mineral exploration I DOUGLAS W. OLDENBURG, YAOGUO LI, and COLIN G. FARQUHARSON, University of British Columbia PETER KOWALCZYK, Placer Dome, Incorporated, Vancouver,

More information

Interpretation Report on Borehole TDEM Surveys

Interpretation Report on Borehole TDEM Surveys Interpretation Report on Borehole TDEM Surveys Junior Lake Property, Armstrong, Ontario For Landore Resources Canada Inc. Alan R. King, M.Sc., P.Geo. January 25, 2016 Introduction Alan King of Geoscience

More information

SEAM2: 3D NON-SEISMIC MODELING OF A COMPLEX MIDDLE EAST O&G PROSPECT

SEAM2: 3D NON-SEISMIC MODELING OF A COMPLEX MIDDLE EAST O&G PROSPECT 6th International Symposium on Three-Dimensional Electromagnetics Berkeley, California, USA, March 28-3, 217 SEAM2: 3D NON-SEISMIC MODELING OF A COMPLEX MIDDLE EAST O&G PROSPECT M. D. Watts 1, R. L. Mackie

More information

Example: Current in an Electrical Circuit. Solving Linear Systems:Direct Methods. Linear Systems of Equations. Solving Linear Systems: Direct Methods

Example: Current in an Electrical Circuit. Solving Linear Systems:Direct Methods. Linear Systems of Equations. Solving Linear Systems: Direct Methods Example: Current in an Electrical Circuit Solving Linear Systems:Direct Methods A number of engineering problems or models can be formulated in terms of systems of equations Examples: Electrical Circuit

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

Geophysical Journal International

Geophysical Journal International Geophysical Journal International Geophys. J. Int. (2013) 192, 602 612 doi: 10.1093/gji/ggs040 Inductive source induced polarization David Marchant, Eldad Haber and Douglas W. Oldenburg Department of Earth

More information

Case Study: Ground TEM survey over the Champagne deposit, Qc.

Case Study: Ground TEM survey over the Champagne deposit, Qc. Case Study: Ground TEM survey over the Champagne deposit, Qc. Circé Malo Lalande, Eng. Geophysicist www.gdd.ca Survey site Localisation Champagne deposit Bellechasse Gold Belt Golden Hope Mine ltd. 2 Exploration

More information

Review Questions REVIEW QUESTIONS 71

Review Questions REVIEW QUESTIONS 71 REVIEW QUESTIONS 71 MATLAB, is [42]. For a comprehensive treatment of error analysis and perturbation theory for linear systems and many other problems in linear algebra, see [126, 241]. An overview of

More information

TIV Contrast Source Inversion of mcsem data

TIV Contrast Source Inversion of mcsem data TIV Contrast ource Inversion of mcem data T. Wiik ( ), L. O. Løseth ( ), B. Ursin ( ), K. Hokstad (, ) ( )epartment for Petroleum Technology and Applied Geophysics, Norwegian University of cience and Technology

More information

In The Shadow of a Headframe: Deep Exploration Using Integrated 3-D Seismic and BHEM Aat The Louvicourt Mine, Quebec

In The Shadow of a Headframe: Deep Exploration Using Integrated 3-D Seismic and BHEM Aat The Louvicourt Mine, Quebec Geophysical Case Histories In The Shadow of a Headframe: Deep Exploration Using Integrated 3-D Seismic and BHEM Aat The Louvicourt Mine, Quebec 1. SEISServ, Quebec City, Quebec, Canada 2. Geoserve Logging

More information

A projected Hessian for full waveform inversion

A projected Hessian for full waveform inversion CWP-679 A projected Hessian for full waveform inversion Yong Ma & Dave Hale Center for Wave Phenomena, Colorado School of Mines, Golden, CO 80401, USA (c) Figure 1. Update directions for one iteration

More information

A Scalable, Parallel Implementation of Weighted, Non-Linear Compact Schemes

A Scalable, Parallel Implementation of Weighted, Non-Linear Compact Schemes A Scalable, Parallel Implementation of Weighted, Non-Linear Compact Schemes Debojyoti Ghosh Emil M. Constantinescu Jed Brown Mathematics Computer Science Argonne National Laboratory SIAM Annual Meeting

More information

Numerical modeling of Z-TEM (airborne AFMAG) responses to guide exploration strategies Bob Lo*, Geotech Ltd., Michael Zang, Exploration Syndicate Inc.

Numerical modeling of Z-TEM (airborne AFMAG) responses to guide exploration strategies Bob Lo*, Geotech Ltd., Michael Zang, Exploration Syndicate Inc. Bob Lo*, Geotech Ltd., Michael Zang, Exploration Syndicate Inc. Summary Mineral exploration using the Z-TEM or Z-Axis Tipper Electromagnetics, an airborne AFMAG system, has been guided by numerical modeling

More information

VTEM-ZTEM Airborne EM Survey. Results over PGM-Cu-Ni Targets. at East Bull Lake Anorthositic Complex, Massey, ON

VTEM-ZTEM Airborne EM Survey. Results over PGM-Cu-Ni Targets. at East Bull Lake Anorthositic Complex, Massey, ON KEGS-PDAC SYMPOSIUM 2011 Meeting Geophysical Challenges: Difficult Environments and Hard to Detect Commodities VTEM-ZTEM Airborne EM Survey Results over PGM-Cu-Ni Targets at East Bull Lake Anorthositic

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Preliminary Examination, Numerical Analysis, August 2016

Preliminary Examination, Numerical Analysis, August 2016 Preliminary Examination, Numerical Analysis, August 2016 Instructions: This exam is closed books and notes. The time allowed is three hours and you need to work on any three out of questions 1-4 and any

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

CLASSICAL ITERATIVE METHODS

CLASSICAL ITERATIVE METHODS CLASSICAL ITERATIVE METHODS LONG CHEN In this notes we discuss classic iterative methods on solving the linear operator equation (1) Au = f, posed on a finite dimensional Hilbert space V = R N equipped

More information

Direct Current Resistivity Inversion using Various Objective Functions

Direct Current Resistivity Inversion using Various Objective Functions Direct Current Resistivity Inversion using Various Objective Functions Rowan Cockett Department of Earth and Ocean Science University of British Columbia rcockett@eos.ubc.ca Abstract In geophysical applications

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 24: Preconditioning and Multigrid Solver Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 5 Preconditioning Motivation:

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

Solving PDEs with CUDA Jonathan Cohen

Solving PDEs with CUDA Jonathan Cohen Solving PDEs with CUDA Jonathan Cohen jocohen@nvidia.com NVIDIA Research PDEs (Partial Differential Equations) Big topic Some common strategies Focus on one type of PDE in this talk Poisson Equation Linear

More information

We Simultaneous Joint Inversion of Electromagnetic and Seismic Full-waveform Data - A Sensitivity Analysis to Biot Parameter

We Simultaneous Joint Inversion of Electromagnetic and Seismic Full-waveform Data - A Sensitivity Analysis to Biot Parameter We-09-04 Simultaneous Joint Inversion of Electromagnetic and Seismic Full-waveform Data - A Sensitivity Analysis to Biot Parameter J. Giraud* (WesternGeco Geosolutions), M. De Stefano (WesternGeco Geosolutions)

More information

Wavefield Reconstruction Inversion (WRI) a new take on wave-equation based inversion Felix J. Herrmann

Wavefield Reconstruction Inversion (WRI) a new take on wave-equation based inversion Felix J. Herrmann Wavefield Reconstruction Inversion (WRI) a new take on wave-equation based inversion Felix J. Herrmann SLIM University of British Columbia van Leeuwen, T and Herrmann, F J (2013). Mitigating local minima

More information

ASX Announcement. FLEM survey underway at Henrietta Cobalt Nickel Prospect, Tasmania ASX: AX8 HIGHLIGHTS. Market Data. Board and Management.

ASX Announcement. FLEM survey underway at Henrietta Cobalt Nickel Prospect, Tasmania ASX: AX8 HIGHLIGHTS. Market Data. Board and Management. FLEM survey underway at Henrietta Cobalt Nickel Prospect, Tasmania ASX Announcement Market Data ASX Code: AX8 Shares on Issue: 47,620,000 Board and Management Grant Mooney Non-Executive Chairman Andrew

More information

Downloaded 08/29/13 to Redistribution subject to SEG license or copyright; see Terms of Use at

Downloaded 08/29/13 to Redistribution subject to SEG license or copyright; see Terms of Use at New approach to 3D inversion of MCSEM and MMT data using multinary model transform Alexander V. Gribenko and Michael S. Zhdanov, University of Utah and TechnoImaging SUMMARY Marine controlled-source electromagnetic

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

Solution of Linear Systems

Solution of Linear Systems Solution of Linear Systems Parallel and Distributed Computing Department of Computer Science and Engineering (DEI) Instituto Superior Técnico May 12, 2016 CPD (DEI / IST) Parallel and Distributed Computing

More information

A wavelet multiscale method for inversion of Maxwell equations

A wavelet multiscale method for inversion of Maxwell equations Appl. Math. Mech. -Engl. Ed. 30(8), 35 44 (2009) DOI:.07/s483-009-08-1 c Shanghai University and Springer-Verlag 2009 Applied Mathematics and Mechanics (English Edition) A wavelet multiscale method for

More information

The Cerattepe Massive Sulphide Property, Northeastern Turkey

The Cerattepe Massive Sulphide Property, Northeastern Turkey Integrated Exploration Case Histories Paper 139 Explor97 Master Page Explor97 Contents Previous Paper G O T O Author Index Section Contents The Cerattepe Massive Sulphide Property, Northeastern Turkey

More information

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

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

More information

Mapping Silicification in Gold Exploration

Mapping Silicification in Gold Exploration Mapping Silicification in Gold Exploration with Inductive Source Resistivity James Macnae and Patrick McGowan, Lamontagne Geophysics Ltd. Lamontagne Geophysics Ltd. 115 Grant Timmins Drive Kingston, Ontario

More information

CHAPTER 10: Numerical Methods for DAEs

CHAPTER 10: Numerical Methods for DAEs CHAPTER 10: Numerical Methods for DAEs Numerical approaches for the solution of DAEs divide roughly into two classes: 1. direct discretization 2. reformulation (index reduction) plus discretization Direct

More information

reservoir Summary A realistic controlled-sourcee Saturation simulations using Archie's is obtained by reservoir level. (Figure 1 and Table 1).

reservoir Summary A realistic controlled-sourcee Saturation simulations using Archie's is obtained by reservoir level. (Figure 1 and Table 1). Sensitivity analysis of 3D surface-borehole McNeice*, EXPEC Advanced Researchh Center, Saudii Aramco, CSEM for a Saudi Arabian carbonate reservoir Daniele Colombo and Gary Garrett Kramer, WesternGeco Summary

More information

Nonsmooth Newton methods for frictional contact problems in flexible multi-body systems

Nonsmooth Newton methods for frictional contact problems in flexible multi-body systems 1/21 Nonsmooth Newton methods for frictional contact problems in flexible multi-body systems V. Acary, M. Brémond, F. Dubois INRIA Rhône Alpes, Grenoble. LMGC Montpellier 13 eme Colloque National en Calcul

More information

DECAY CHARACTERISTICS OF AIRBORNE TIME-DOMAIN ELECTROMAGNETIC DATA: WHERE TO FIND THE CONSTANT (TAU)

DECAY CHARACTERISTICS OF AIRBORNE TIME-DOMAIN ELECTROMAGNETIC DATA: WHERE TO FIND THE CONSTANT (TAU) DECAY CHARACTERISTICS OF AIRBORNE TIME-DOMAIN ELECTROMAGNETIC DATA: WHERE TO FIND THE CONSTANT (TAU) Tau Geophysical Consultants Magdel Combrinck Willem Botha Outline What is? Why is it useful? How is

More information

Migration with Implicit Solvers for the Time-harmonic Helmholtz

Migration with Implicit Solvers for the Time-harmonic Helmholtz Migration with Implicit Solvers for the Time-harmonic Helmholtz Yogi A. Erlangga, Felix J. Herrmann Seismic Laboratory for Imaging and Modeling, The University of British Columbia {yerlangga,fherrmann}@eos.ubc.ca

More information

7.2 Steepest Descent and Preconditioning

7.2 Steepest Descent and Preconditioning 7.2 Steepest Descent and Preconditioning Descent methods are a broad class of iterative methods for finding solutions of the linear system Ax = b for symmetric positive definite matrix A R n n. Consider

More information

New Generation JESSY HTS SQUID Results over the LALOR Deposit

New Generation JESSY HTS SQUID Results over the LALOR Deposit www.livingskygeophysics.ca New Generation JESSY HTS SQUID Results over the LALOR Deposit www.discogeo.com David Bingham, B Sc, P. Geo. Living Sky Geophysics Inc. Grant Nimeck, B Sc, P. Geo., P. Geoph.

More information

C5 Magnetic exploration methods data analysis techniques

C5 Magnetic exploration methods data analysis techniques C5 Magnetic exploration methods data analysis techniques C5.1 Data processing and corrections After magnetic field data have been collected a number of corrections are applied to simplify the interpretation.

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

Spring 2018 Drill Program

Spring 2018 Drill Program VANCOUVER, BC / April 5, 2018 / Margaret Lake Diamonds Inc. (TSX-V: DIA; FSE: M85) ("Margaret Lake" or the "Company") is pleased to report preparations are now underway to commence a diamond drill program

More information

1.Chapter Objectives

1.Chapter Objectives LU Factorization INDEX 1.Chapter objectives 2.Overview of LU factorization 2.1GAUSS ELIMINATION AS LU FACTORIZATION 2.2LU Factorization with Pivoting 2.3 MATLAB Function: lu 3. CHOLESKY FACTORIZATION 3.1

More information

NEWS RELEASE CANADIAN ZINC REPORTS REMAINING DRILL RESULTS AT LEMARCHANT DEPOSIT, SOUTH TALLY POND PROJECT, NEWFOUNDLAND

NEWS RELEASE CANADIAN ZINC REPORTS REMAINING DRILL RESULTS AT LEMARCHANT DEPOSIT, SOUTH TALLY POND PROJECT, NEWFOUNDLAND NEWS RELEASE CZN-TSX CZICF-OTCQB FOR IMMEDIATE RELEASE March 5, 2018 CANADIAN ZINC REPORTS REMAINING DRILL RESULTS AT LEMARCHANT DEPOSIT, SOUTH TALLY POND PROJECT, NEWFOUNDLAND 2017 drill program successfully

More information

arxiv: v1 [math.na] 5 May 2011

arxiv: v1 [math.na] 5 May 2011 ITERATIVE METHODS FOR COMPUTING EIGENVALUES AND EIGENVECTORS MAYSUM PANJU arxiv:1105.1185v1 [math.na] 5 May 2011 Abstract. We examine some numerical iterative methods for computing the eigenvalues and

More information

Bellhaven Expands the Middle Zone Prospect with New Drilling: Advances toward New Resource in First Half of 2012

Bellhaven Expands the Middle Zone Prospect with New Drilling: Advances toward New Resource in First Half of 2012 Bellhaven Expands the Middle Zone Prospect with New Drilling: Advances toward New Resource in First Half of 2012 Vancouver, British Columbia January 19, 2012. Bellhaven Copper & Gold Inc. (TSX- Venture:

More information

CORPORATE PROFILE Airborne Geophysics for Mineral Exploration

CORPORATE PROFILE Airborne Geophysics for Mineral Exploration CORPORATE PROFILE Airborne Geophysics for Mineral Exploration Highlights Specialists in high resolution airborne geophysical surveys in mountainous terrain Precision GeoSurveys is a full-service airborne

More information

GEOTECH: Airborne Geophysics and Its Possible Application in Bulgaria. Prof. Alexander Antonov, Canada

GEOTECH: Airborne Geophysics and Its Possible Application in Bulgaria. Prof. Alexander Antonov, Canada GEOTECH: Airborne Geophysics and Its Possible Application in Bulgaria Prof. Alexander Antonov, Canada Geotech overview Geotech Ltd is a global leader in airborne geophysical survey, mapping, interpretation

More information

Topic 17. Analysis of Algorithms

Topic 17. Analysis of Algorithms Topic 17 Analysis of Algorithms Analysis of Algorithms- Review Efficiency of an algorithm can be measured in terms of : Time complexity: a measure of the amount of time required to execute an algorithm

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information