03. Simulation#

The easiest way to model CSEM data for a survey is to make use of the Survey and Simulation classes, emg3d.surveys.Survey and emg3d.simulations.Simulation, respectively, together with the automatic gridding functionality.

For this example we use the resistivity model created in the example GemPy-II: Perth Basin.

import os
import pooch
import emg3d
import numpy as np
import matplotlib.pyplot as plt
from matplotlib.colors import LogNorm
from scipy.interpolate import RectBivariateSpline
plt.style.use('bmh')


# Adjust this path to a folder of your choice.
data_path = os.path.join('..', 'download', '')

Fetch the model#

Retrieve and load the pre-computed resistivity model.

fname = "GemPy-II.h5"
pooch.retrieve(
    'https://raw.github.com/emsig/data/2021-05-21/emg3d/models/'+fname,
    'ea8c23be80522d3ca8f36742c93758370df89188816f50cb4e1b2a6a3012d659',
    fname=fname,
    path=data_path,
)
model = emg3d.load(data_path + fname)['model']
Data loaded from «/home/dtr/3-GitHub/emsig/emg3d-gallery/examples/download/GemPy-II.h5»
[emg3d v1.0.0rc3.dev5+g0cd9e09 (format 1.0) on 2021-05-21T18:40:16.721968].

Let’s check the model

Model: resistivity; isotropic; 100 x 100 x 102 (1,020,000)

So it is an isotropic model defined in terms of resistivities. Let’s check the grid

TensorMesh 1,020,000 cells
MESH EXTENT CELL WIDTH FACTOR
dir nC min max min max max
x 100 0.00 20,000.00 200.00 200.00 1.00
y 100 0.00 20,000.00 200.00 200.00 1.00
z 102 -7,000.00 500.00 50.00 2,000.00 40.00


Define the survey#

If you have actual field data then this info would normally come from a data file or similar. Here we create our own dummy survey, and later will create synthetic data for it.

A Survey instance contains all survey-related information, hence source and receiver positions and measured data. See the relevant documentation for more details: emg3d.surveys.Survey.

Extract seafloor to simulate source and receiver depths#

To create a realistic survey we create a small routine that finds the seafloor, so we can place receivers on the seafloor and sources 50 m above it. We use the fact that the seawater has resistivity of 0.3 Ohm.m in the model, and is the lowest value.

seafloor = np.ones((grid.shape_cells[0], grid.shape_cells[1]))
for i in range(grid.shape_cells[0]):
    for ii in range(grid.shape_cells[1]):
        # We take the seafloor to be the first cell which resistivity
        # is below 0.33
        seafloor[i, ii] = grid.nodes_z[:-1][
                model.property_x[i, ii, :] < 0.33][0]

# Create a 2D interpolation function from it
bathymetry = RectBivariateSpline(
        grid.cell_centers_x, grid.cell_centers_y, seafloor)

Source and receiver positions#

Sources and receivers can be defined in a few different ways. One way is by providing coordinates, where two coordinate formats are accepted:

  • (x0, x1, y0, y1, z0, z1): finite length dipole,

  • (x, y, z, azimuth, elevation): point dipole,

where the angles (azimuth and elevation) are in degrees. For the coordinate system see coordinate_system.

A survey can contain electric and magnetic receivers, arbitrarily rotated. However, the Simulation is currently limited to electric receivers.

Note that the survey just knows about the sources, receivers, frequencies, and observed data - it does not know anything of an underlying model.

# Angles for horizontal, x-directed Ex point dipoles
elevation = 0.0
azimuth = 0.0

# Acquisition source frequencies (Hz)
frequencies = [0.5, 1.0]

# Source coordinates
src_x = np.arange(1, 4)*5000
src_y = 7500
# Source depths: 50 m above seafloor
src_z = bathymetry(src_x, src_y).ravel()+50
src = emg3d.surveys.txrx_coordinates_to_dict(
        emg3d.TxElectricDipole,
        (src_x, src_y, src_z, azimuth, elevation)
)

# Receiver positions
rec_x = np.arange(3, 18)*1e3
rec_y = np.arange(3)*1e3+6500
RX, RY = np.meshgrid(rec_x, rec_y, indexing='ij')
RZ = bathymetry(rec_x, rec_y)
rec = emg3d.surveys.txrx_coordinates_to_dict(
        emg3d.RxElectricPoint,
        (RX.ravel(), RY.ravel(), RZ.ravel(), azimuth, elevation)
)

Create Survey#

If you have observed data you can provide them, here we will create synthetic data later on. What you have to define is the expected noise floor and relative error, which is used to compute the misfit later on. Alternatively you can provide directly the standard deviation; see emg3d.surveys.Survey.

survey = emg3d.surveys.Survey(
    name='GemPy-II Survey A',  # Name of the survey
    sources=src,               # Source coordinates
    receivers=rec,             # Receiver coordinates
    frequencies=frequencies,   # Two frequencies
    # data=data,               # If you have observed data
    noise_floor=1e-15,
    relative_error=0.05,
)

# Let's have a look at the survey:
survey

Survey «GemPy-II Survey A»

<xarray.Dataset>
Dimensions:   (src: 3, rec: 45, freq: 2)
Coordinates:
  * src       (src) <U6 'TxED-1' 'TxED-2' 'TxED-3'
  * rec       (rec) <U7 'RxEP-01' 'RxEP-02' 'RxEP-03' ... 'RxEP-44' 'RxEP-45'
  * freq      (freq) <U3 'f-1' 'f-2'
Data variables:
    observed  (src, rec, freq) complex128 (nan+nanj) (nan+nanj) ... (nan+nanj)
Attributes:
    noise_floor:     1e-15
    relative_error:  0.05


Our survey has our sources and receivers and initiated a variable observed, with NaN’s. Each source and receiver got a name assigned. If you prefer other names you would have to define the sources and receivers through emg3d.surveys.Dipole, and provide a list of dipoles to the survey instead of only a tuple of coordinates.

We can also look at a particular source or receiver, e.g.,

survey.sources['TxED-1']
TxElectricDipole: 1.0 A;
    center={5,000.0; 7,500.0; -2,305.8} m; θ=0.0°, φ=0.0°; l=1.0 m

Which shows you all you need to know about a particular dipole: name, type (electric or magnetic), coordinates of its center, angles, and length.

QC model and survey#

grid.plot_3d_slicer(model.property_x, xslice=12000, yslice=7500,
                    pcolor_opts={'norm': LogNorm(vmin=0.3, vmax=200)})

# Plot survey in figure above
fig = plt.gcf()
fig.suptitle('Resistivity model (Ohm.m) and survey layout')
axs = fig.get_children()
rec_coords = survey.receiver_coordinates()
src_coords = survey.source_coordinates()
axs[1].plot(rec_coords[0], rec_coords[1], 'bv')
axs[2].plot(rec_coords[0], rec_coords[2], 'bv')
axs[3].plot(rec_coords[2], rec_coords[1], 'bv')
axs[1].plot(src_coords[0], src_coords[1], 'r*')
axs[2].plot(src_coords[0], src_coords[2], 'r*')
axs[3].plot(src_coords[2], src_coords[1], 'r*')
plt.show()
Resistivity model (Ohm.m) and survey layout

Create a Simulation (to compute ‘observed’ data)#

The simulation class combines a model with a survey, and can compute synthetic data for it.

Automatic gridding#

We use the automatic gridding feature implemented in the simulation class to use source- and frequency- dependent grids for the computation. Consult the following docs for more information:

gopts = {
    'properties': [0.3, 10, 1., 0.3],
    'min_width_limits': (100, 100, 50),
    'stretching': (None, None, [1.05, 1.5]),
    'domain': (
        [rec_coords[0].min()-100, rec_coords[0].max()+100],
        [rec_coords[1].min()-100, rec_coords[1].max()+100],
        [-5500, -2000]
    ),
    'center_on_edge': False,
}

Now we can initiate the simulation class and QC it:

simulation = emg3d.simulations.Simulation(
    name="True Model",    # A name for this simulation
    survey=survey,        # Our survey instance
    model=model,          # The model
    gridding='both',      # Frequency- and source-dependent meshes
    max_workers=4,        # How many parallel jobs
    # solver_opts,        # Any parameter to pass to emg3d.solve
    gridding_opts=gopts,  # Gridding options
)

# Let's QC our Simulation instance
simulation

Simulation «True Model»

  • Survey «GemPy-II Survey A»: 3 sources; 45 receivers; 2 frequencies
  • Model: resistivity; isotropic; 100 x 100 x 102 (1,020,000)
  • Gridding: Frequency- and source-dependent grids; 192 x 48 x 48 (442,368)


Compute the data#

We pass here the argument observed=True; this way, the synthetic data is stored in our Survey as observed data, otherwise it would be stored as synthetic. This is important later for optimization. It also adds Gaussian noise according to the noise floor and relative error we defined in the survey. By setting a minimum offset the receivers close to the source are switched off.

This computes all results in parallel; in this case six models, three sources times two frequencies. You can change the number of workers at any time by setting simulation.max_workers.

simulation.compute(observed=True, min_offset=500)
Compute efields            0/6  [00:00]
Compute efields #6         1/6  [01:24]
Compute efields ########3  5/6  [02:09]
Compute efields ########## 6/6  [02:09]

A Simulation has a few convenience functions, e.g.:

  • simulation.get_efield('TxED-1', 0.5): Returns the electric field of the entire domain for source 'TxED-1' and frequency 0.5 Hz.

  • simulation.get_hfield; simulation.get_sfield: Similar functions to retrieve the magnetic fields and the source fields.

  • simulation.get_model; simulation.get_grid: Similar functions to retrieve the computational grid and the model for a given source and frequency.

When we now look at our survey we see that the observed data variable is filled with the responses at the receiver locations. Note that the synthetic data is the actual computed data, the observed data, on the other hand, has Gaussian noise added and is set to NaN’s for positions too close to the source.

Survey «GemPy-II Survey A»

<xarray.Dataset>
Dimensions:    (src: 3, rec: 45, freq: 2)
Coordinates:
  * src        (src) <U6 'TxED-1' 'TxED-2' 'TxED-3'
  * rec        (rec) <U7 'RxEP-01' 'RxEP-02' 'RxEP-03' ... 'RxEP-44' 'RxEP-45'
  * freq       (freq) <U3 'f-1' 'f-2'
Data variables:
    observed   (src, rec, freq) complex128 (-7.663569768214042e-14-5.28813594...
    synthetic  (src, rec, freq) complex128 (-6.068521242448416e-14-5.08742798...
Attributes:
    noise_floor:     1e-15
    relative_error:  0.05


QC Data#

plt.figure()
plt.title("Inline receivers for all sources")
obs = simulation.data.observed[:, 1::3, :]
syn = simulation.data.synthetic[:, 1::3, :]
for i, src in enumerate(survey.sources.keys()):
    for ii, freq in enumerate(survey.frequencies):
        plt.plot(rec_coords[0][1::3],
                 abs(syn.loc[src, :, freq].data.real),
                 "k-", lw=0.5)
        plt.plot(rec_coords[0][1::3],
                 abs(syn.loc[src, :, freq].data.imag),
                 "k-", lw=0.5)
        plt.plot(rec_coords[0][1::3],
                 abs(obs.loc[src, :, freq].data.real),
                 f"C{ii}.-",
                 label=f"|Real|; freq={freq} Hz" if i == 0 else None
                 )
        plt.plot(rec_coords[0][1::3],
                 abs(obs.loc[src, :, freq].data.imag),
                 f"C{ii}.--",
                 label=f"|Imag|; freq={freq} Hz" if i == 0 else None
                 )

plt.yscale('log')
plt.legend(ncol=2, framealpha=1)
plt.xlabel('x-coordinate (m)')
plt.ylabel('$|E_x|$ (V/m)')
plt.show()
Inline receivers for all sources

How to store surveys and simulations to disk#

Survey and Simulations can store (and load) themselves to (from) disk.

  • A survey stores all sources, receivers, frequencies, and the observed data.

  • A simulation stores the survey, the model, the synthetic data. (It can also store much more, such as all electric fields, source and frequency dependent meshes and models, etc. What it actually stores is defined by the parameter what).

# Survey file name
# survey_fname = 'GemPy-II-survey-A.h5'

# To store, run
# survey.to_file(survey_fname)  # .h5, .json, or .npz

# To load, run
# survey = emg3d.surveys.Survey.from_file(survey_fname)

# In the same manner you could store and load the entire simulation:

# Simulation file name
# simulation_fname = file-name.ending  # for ending in [h5, json, npz]

# To store, run
# simulation.to_file(simulation_fname, what='results')

# To load, run
# simulation = emg3d.simulations.Simulation.from_file(simulation_fname)
Wed Aug 31 21:27:33 2022 CEST
OS Linux CPU(s) 4 Machine x86_64
Architecture 64bit RAM 15.5 GiB Environment Python
File system ext4
Python 3.9.12 | packaged by conda-forge | (main, Mar 24 2022, 23:22:55) [GCC 10.3.0]
numpy 1.22.4 scipy 1.9.0 numba 0.55.2
emg3d 1.8.0 empymod 2.2.0 xarray 2022.6.0
discretize 0.8.2 h5py 3.7.0 matplotlib 3.4.3
tqdm 4.64.0 IPython 8.4.0
Intel(R) oneAPI Math Kernel Library Version 2022.0-Product Build 20211112 for Intel(R) 64 architecture applications


Total running time of the script: ( 2 minutes 16.637 seconds)

Estimated memory usage: 223 MB

Gallery generated by Sphinx-Gallery