2025-11-19T05:01:13.840438

Bi-level regularization via iterative mesh refinement for aeroacoustics

Aarset, Nguyen
In this work, we illustrate the connection between adaptive mesh refinement for finite element discretized PDEs and the recently developed \emph{bi-level regularization algorithm}. By adaptive mesh refinement according to data noise, regularization effect and convergence are immediate consequences. We moreover demonstrate its numerical advantages to the classical Landweber algorithm in term of time and reconstruction quality for the example of the Helmholtz equation in an aeroacoustic setting.
academic

Bi-level regularization via iterative mesh refinement for aeroacoustics

Basic Information

  • Paper ID: 2409.06854
  • Title: Bi-level regularization via iterative mesh refinement for aeroacoustics
  • Authors: Christian Aarset (University of Göttingen), Tram Thi Ngoc Nguyen (MPI Solar Systems Research)
  • Classification: math.NA cs.NA math.OC
  • Publication Date: September 2024 (arXiv:2409.06854v3 math.NA 31 Oct 2024)
  • Paper Link: https://arxiv.org/abs/2409.06854

Abstract

This paper elucidates the connection between adaptive mesh refinement for finite element discretization of partial differential equations and the recently developed bi-level regularization algorithm. Through adaptive mesh refinement based on data noise, regularization effects and convergence are natural consequences. The authors further demonstrate the numerical advantages of this method over the classical Landweber algorithm in terms of computational time and reconstruction quality, using the application of the Helmholtz equation in aeroacoustic environments as an example.

Research Background and Motivation

Problem Background

  1. Challenges in inverse source problems: In aeroacoustics, it is necessary to determine unknown acoustic sources from measured data of acoustic oscillations. This is a typical inverse problem that is ill-posed due to the non-injectivity and compactness of the observation operator.
  2. Limitations of traditional methods: Although the classical Landweber iterative algorithm can handle such inverse problems, it suffers from insufficient computational efficiency and reconstruction quality, particularly lacking adaptivity when processing data with varying noise levels.
  3. Development of bi-level regularization: The bi-level regularization algorithm proposed by Nguyen in 2024 provides a new framework in which the upper-level iteration approximates unknown parameters while the lower-level iteration inexactly solves nonlinear partial differential equations.

Research Motivation

The core motivation of this paper is to combine the bi-level regularization algorithm with adaptive mesh refinement techniques, achieving dual improvements in computational efficiency and reconstruction accuracy by dynamically adjusting mesh precision according to data noise levels.

Core Contributions

  1. Theoretical connection: Establishes for the first time the theoretical link between adaptive mesh refinement and the bi-level regularization algorithm, demonstrating how mesh refinement strategies naturally integrate into the bi-level framework.
  2. Algorithm implementation: Proposes a bi-level regularization algorithm based on the finite element method combined with iterative mesh refinement strategy, capable of adaptively adjusting computational precision according to data noise levels.
  3. Numerical verification: Through aeroacoustic applications of the Helmholtz equation, demonstrates significant advantages of this method over traditional Landweber algorithms in computational time and reconstruction quality.
  4. Stopping criteria: Provides stopping criteria for both upper-level and lower-level iterations, ensuring algorithm convergence and regularization effects.

Methodology Details

Problem Formulation

Consider a bounded Lipschitz domain Ω ⊂ ℝ², which contains:

  • Source domain Ω₀ ⊂ int Ω, containing unknown true source φ ∈ L²(Ω₀)
  • Measurement domain Ω₁ ⊂ Ω, disjoint from the source domain, containing three rectangular acoustically hard scatterers Sᵢ (i=1,2,3)

The objective is to reconstruct the unknown acoustic source φ from noisy measurement data y^δ.

Mathematical Model

Acoustic wave propagation is described by the homogeneous Helmholtz equation:

Δu + k²u = φ  in Ω \ ⋃ᵢ₌₁³ Sᵢ
∂u/∂n = iku   on ∂Ω (Sommerfeld radiation condition)
∂u/∂n = 0     on ⋃ᵢ₌₁³ ∂Sᵢ (acoustically hard boundary)

where k ∈ ℝ is the wavenumber and n is the outward normal vector.

Bi-level Regularization Framework

Upper-level iteration: Updates the source term using Landweber iteration:

φʲ⁺¹ = φʲ - μF*ʰ⁽δ,ʲ⁾(Fʰ⁽δ,ʲ⁾φʲ - y^δ)

Lower-level iteration: Solves the PDE through adaptive mesh refinement with accuracy requirement εⱼ = δ/qʲ, where q ≥ 1.

Mesh Refinement Strategy

Based on theoretical analysis, mesh size hⱼ is proportional to approximation error εⱼ: εⱼ = Chⱼ. When j ≥ (ln δ - ln Ch₀)/ln q, mesh elements corresponding to large h values require refinement.

Adjoint Operator

The adjoint operator F* is derived through variational methods:

F*v := Re(z)|Ω₀

where z satisfies the adjoint equation:

Δz + k²z = v  in Ω \ ⋃ᵢ₌₁³ Sᵢ
∂z/∂n = -ikz  on ∂Ω
∂z/∂n = 0     on ⋃ᵢ₌₁³ ∂Sᵢ

Experimental Setup

Problem Configuration

  • Computational domain: Ω = -1,1²
  • Source domain: Ω₀ = -1/2,1/2²
  • Measurement domain: Ω₁ = -1,1² \ -11/20,11/20²
  • True source function:
    φ(x₁,x₂) = √min{1/4 - x₁² - x₂², 0} cos(2π√(x₁² + x₂²))
    

Numerical Implementation

  • Finite element package: NGSolve
  • True state generation: Fine mesh h† ≈ 0.046
  • Noise levels: 1% and 10% Gaussian white noise
  • Step size: μ ≈ 0.075
  • Stopping criterion: Discrepancy principle ‖y^δ - Fφʲ‖₂ ≤ τδ, τ = 1.3

Comparison Methods

  1. Bi-level Landweber algorithm: Initial coarse mesh h₀ ≈ 0.531, q = 2^(1/60), C = 1.4/δ
  2. Direct Landweber algorithm: Fixed mesh hdirect ≈ 0.064

Experimental Results

Main Results

For both 1% and 10% relative noise levels, the bi-level algorithm reaches the stopping criterion of the discrepancy principle earlier than the direct Landweber algorithm.

1% noise case:

  • Bi-level algorithm undergoes three mesh refinements, achieving higher precision in shorter time
  • Although final reconstruction quality is slightly inferior to the direct method, it maintains better performance for most of the iteration

10% noise case:

  • Bi-level algorithm requires only one mesh refinement
  • Outperforms the direct Landweber method in all aspects
  • Validates the intuition that high noise levels can be efficiently handled with coarse meshes

Computational Efficiency Analysis

Experimental results demonstrate that the bi-level algorithm achieves effective utilization of computational resources through adaptive mesh refinement:

  • Uses coarse meshes at high noise levels, reducing computational cost
  • Progressively refines meshes as iterations proceed and precision requirements increase
  • Significantly reduces overall computational time

Bi-level Algorithm Development

  • Nguyen (2024) proposed bi-level iterative regularization providing a new framework for nonlinear PDE inverse problems
  • The key advantage of this method is its ability to embed arbitrary PDE solvers (finite differences, finite elements, multigrid methods, etc.)

Adaptive Mesh Refinement

  • Traditional adaptive mesh refinement primarily focuses on PDE solution accuracy
  • This paper is the first to combine it with inverse problem regularization, achieving unification of computational efficiency and regularization effects

Aeroacoustic Inverse Problems

  • Source localization and reconstruction are important problems in aeroacoustics
  • The Helmholtz equation provides an appropriate mathematical model for single-frequency acoustic wave propagation

Conclusions and Discussion

Main Conclusions

  1. Theoretical contribution: Successfully establishes the theoretical connection between adaptive mesh refinement and bi-level regularization
  2. Algorithm advantages: Bi-level algorithm outperforms traditional methods in both computational efficiency and reconstruction quality
  3. Practical value: This method is particularly suitable for processing data with varying noise levels

Limitations

  1. Model restrictions: Current implementation applies only to linear Helmholtz equations
  2. Two-dimensional limitation: Numerical experiments are conducted only in two dimensions
  3. Parameter tuning: Algorithm parameters q and C require adjustment for specific problems

Future Directions

The authors indicate that recent developments in bi-level algorithms open new application prospects in optimal experimental design (OED), particularly in extensions to nonlinear cases.

In-depth Evaluation

Strengths

  1. High innovation: First combination of bi-level regularization with adaptive mesh refinement, with significant theoretical contributions
  2. High practical value: Algorithm demonstrates clear advantages in practical aeroacoustic problems
  3. Rigorous theory: Provides complete mathematical derivations and convergence analysis
  4. Sufficient experiments: Validates method effectiveness through comparative experiments at different noise levels

Weaknesses

  1. Limited application scope: Verification only on specific aeroacoustic problems, lacking broader application testing
  2. Insufficient parameter sensitivity analysis: Analysis of sensitivity to key algorithm parameters is insufficient
  3. Lack of three-dimensional extension: Absence of numerical verification in three dimensions

Impact

This work provides a new computational framework for inverse problem solving and is expected to have significant impact in computational mathematics and engineering applications. Particularly in large-scale inverse problems requiring different precision requirements, this method has substantial practical value.

Applicable Scenarios

  1. Aeroacoustics: Source localization and noise control
  2. Seismic exploration: Subsurface structure imaging
  3. Medical imaging: Ultrasound and photoacoustic imaging
  4. Nondestructive testing: Defect identification and localization

References

The paper cites 10 related references covering important works in optimal experimental design, finite element methods, inverse scattering theory, multigrid methods, and other related fields, providing a solid theoretical foundation for the research.


Overall Assessment: This is a high-quality computational mathematics paper that successfully combines theoretical innovation with practical applications. The combination of bi-level regularization and adaptive mesh refinement provides new insights for inverse problem solving, with significant academic value and application prospects.