Papers
Topics
Authors
Recent
2000 character limit reached

Forward and Inversion Combination Procedure

Updated 18 December 2025
  • The procedure is a computational method combining the scaled boundary finite element method (SBFEM) with full-waveform inversion to reconstruct spatial density from time-domain data in heterogeneous media.
  • It employs semi-weak spatial discretization, adjoint-based gradient computation, and a two-level L-BFGS optimization to enhance accuracy and convergence.
  • Innovations such as on-the-fly elemental condensation and parallel processing enable scalable performance and reduced computational cost.

The forward and inversion combination procedure refers to the integrated computational and algorithmic strategy for reconstructing spatial fields (such as density) from indirect time-domain measurements, specifically in the context of full-waveform inversion (FWI) employing the scaled boundary finite element method (SBFEM). This approach synthesizes a detailed semi-weak spatial-temporal discretization, adjoint-based gradient calculation, and advanced quasi-Newton optimization. It features key innovations in the condensed assembly of element-level matrices and hierarchical parameter updates, yielding high computational efficiency and parallelizability in large-scale heterogenous media (Daneshyar et al., 12 Jan 2025).

1. Governing Equations and Physical Setting

The objective is the estimation of a spatially varying density ρ(x)\rho(x) in a domain Ω\Omega based on observations of a scalar wavefield u(x,t)u(x,t) driven by a prescribed source f(x,t)f(x,t). The heterogeneous acoustic wave equation is posed as: Lu=(ρc2u)ρt2u=f(x,t)\mathcal{L}u = \nabla \cdot (\rho c^2 \nabla u) - \rho\,\partial_t^2 u = f(x,t) for xΩx \in \Omega, t[0,T]t \in [0,T], with initial conditions u(x,0)=0u(x,0) = 0, tu(x,0)=0\partial_t u(x,0) = 0, and free-surface boundary condition un=0\nabla u \cdot n = 0 on Ω\partial\Omega. Here, c(x)c(x) denotes the spatially varying wave speed. This formulation ensures the full density-derivative terms are retained in the forward model, a necessity for high-fidelity inversion in media with non-constant density.

2. Scaled Boundary Semi-Weak Discretization

The SBFEM partitions the computational domain into polygonal elements, each parameterized by a radial coordinate ξ[0,1]\xi \in [0,1] from a scaling center and a circumferential coordinate η\eta. The spatial operators are mapped to this local coordinate system through chain-rule transformations of derivatives: ξ2E0(ξ)ξ2u+ξ[E0+E1TE1+ξE0,ξ]ξu[E2ξE1,ξT]uξ2M0(ξ)t2u=0.\xi^2 E_0(\xi) \partial^2_\xi \mathbf{u} +\xi[E_0 + E_1^T - E_1 + \xi E_{0,\xi}] \partial_\xi\mathbf{u} - [E_2 - \xi E_{1,\xi}^T]\mathbf{u} - \xi^2 M_0(\xi) \partial_t^2 \mathbf{u} = 0. The matrices E0(ξ),E1(ξ),E2(ξ),M0(ξ)E_0(\xi), E_1(\xi), E_2(\xi), M_0(\xi) are boundary integrals over shape functions and Jacobian determinants, explicitly dependent on the local density and wave speed. Crucially, terms like E0,ξE_{0,\xi} and E1,ξE_{1,\xi} (radial derivatives of the coefficients) account for spatial variation of density, a capability absent in legacy SBFEM.

3. Adjoint-State Method and Fréchet Gradient Computation

Parameter estimation is cast as minimization of the data misfit functional: J[ρ]=12r0T(u(xr,t)d(xr,t))2dt,J[\rho] = \frac12 \sum_r \int_0^T (u(x_r, t) - d(x_r, t))^2 \, dt, where d(xr,t)d(x_r, t) denotes receiver data. Introducing a Lagrange multiplier (adjoint wavefield) λ(x,t)\lambda(x,t) linked via the wave equation, one derives the adjoint problem: (ρc2λ)ρt2λ=(ud)rδ(xxr)\nabla \cdot (\rho c^2 \nabla \lambda) - \rho \partial_t^2 \lambda = (u - d) \sum_r \delta(x - x_r) with terminal conditions λ(x,T)=0\lambda(x,T) = 0, tλ(x,T)=0\partial_t \lambda(x,T) = 0. The Fréchet derivative (sensitivity kernel) for JJ with respect to ρ\rho is given by: δJδρ(x)=0T[tλtuc2λu](x,t)dt.\frac{\delta J}{\delta \rho}(x) = \int_0^T [ \partial_t \lambda \, \partial_t u - c^2 \nabla \lambda \cdot \nabla u ](x,t) \, dt. Forward propagation is performed first, followed by time-reversed adjoint propagation. Zero-lag cross-correlations between λ\lambda and uu at each spatial point accumulate the gradient with respect to ρ\rho.

4. Radial Discretization and On-the-Fly Elemental Condensation

Temporal discretization of the system employs Newmark’s method; spatially, the radial coordinate is discretized using central finite differences on a grid ξ0=0<ξ1<<ξn=1\xi_0=0 < \xi_1 < \cdots < \xi_n=1: ξuiui+1ui12h,ξ2uiui+12ui+ui1h2.\partial_\xi \mathbf{u}_i \approx \frac{\mathbf{u}_{i+1} - \mathbf{u}_{i-1}}{2h}, \quad \partial^2_\xi \mathbf{u}_i \approx \frac{\mathbf{u}_{i+1} - 2\mathbf{u}_i + \mathbf{u}_{i-1}}{h^2}. At each time step, the semi-discretized system yields a local tridiagonal linear system per element. An element-level Thomas algorithm (Gaussian elimination) serially eliminates interior unknowns, producing a 2×22 \times 2 nodal system for the element’s boundary. The local dynamic stiffness matrices and equivalent nodal sources are assembled into the global FEM system. This “on-the-fly” assembly avoids introducing auxiliary variables in the global solve, reducing both memory and computational expense.

5. Two-Level L-BFGS Optimization and Parameter Hierarchy

The inversion cycle consists of: (i) assembling the full cost J[ρ]J[\rho] via SBFEM forward simulation, (ii) computing the gradient with a single adjoint solve, and (iii) parameter update using a limited-memory BFGS scheme: ρ(k+1)=ρ(k)αkHk1J[ρ(k)],\rho^{(k+1)} = \rho^{(k)} - \alpha_k H_k^{-1} \nabla J[\rho^{(k)}], where Hk1H_k^{-1} is the L-BFGS quasi-inverse Hessian constructed from the previous mm gradients and updates, and αk\alpha_k is chosen by line search to ensure sufficient descent. The “two-level” optimization hierarchy refers to solving the PDEs and computing the gradient on a coarser mesh for speed, with the density parameters (and gradients) interpolated or mapped onto a finer grid for resolution enhancement.

6. Computational Decomposition and Parallel Efficiency

Each element’s dynamic stiffness is computed independently, reducing the local tridiagonal solves to O(n)O(n) per element, and the global stiffness matrix assembly and solution to O(N)O(N) per time step (N=N= total nodes). Both steps are highly amenable to shared-memory parallelization: the element-local condensation, global matrix assembly, and time-stepping loops for both forward and adjoint propagation are all dispatchable over threads. On a 12-thread laptop (AMD Ryzen 7 PRO 6850U), the wall-clock for a full epoch (forward+adjoint+gradient+L-BFGS update) is 2.4\approx2.4\,s for a mesh with 2000 elements and 5 radial intervals per element, demonstrating robust scalability and strong performance relative to alternative formulations (Daneshyar et al., 12 Jan 2025).

7. Impact and Limitations

The fully coupled forward-inversion procedure in the SBFEM framework achieves accurate imaging in media with strong heterogeneity and spatially varying density, outperforming earlier methods (such as those neglecting density derivatives). The local condensation approach effectively decomposes the global computational load and enhances parallelizability. The method is suited for a range of scales and architectures, delivering high-fidelity solutions at substantially reduced computational cost. The main limitations pertain to the need for sufficiently fine radial discretization to resolve boundary effects and the adequacy of the SBFEM mesh for the spatial variability of ρ(x)\rho(x). Use of the full, non-simplified differential operator is essential for inversion quality; neglecting density derivatives significantly degrades the solution (Daneshyar et al., 12 Jan 2025).

Definition Search Book Streamline Icon: https://streamlinehq.com
References (1)

Whiteboard

Topic to Video (Beta)

Follow Topic

Get notified by email when new papers are published related to Forward and Inversion COmbination Procedure.