Acoustic Wave Model

Ewert and Schröder presented a family of Acoustic Perturbation Equations (APE) for the simulation of flow-induced acoustic fields. These equations describe noise source terms that are determined by unsteady simulations of compressible or incompressible problems. As Lighthill derived an acoustic analogy from the basic equations of Navier-Stokes, an acoustic wave equation can be derived starting from the acoustic perturbation equations as well.

This model calculates the acoustic pressure history on the whole domain, including the effects of convection and refraction.

See [887] and [901].

The complete system of the acoustic perturbation equations in terms of the perturbation variables (p,ua) is given as

Figure 1. EQUATION_DISPLAY
pt+c2∇⋅(ρ¯ua+v¯pc2)0
(4711)
Figure 2. EQUATION_DISPLAY
uat+(v¯ua)+(pρ¯)Φp
(4712)

where:

  • p is the perturbation pressure
  • u a is the irrotational perturbation velocity
  • ρ ¯ is the time-averaged density
  • v ¯ is the time-averaged (mean) velocity
  • c is the speed of sound
  • Φ p is the noise source function

Using the relationship p = ρ ¯ Φ p + p a (where p a is the acoustic pressure) from Ewert and Schroder and taking the substantial derivative ( t + v ¯ ) of Eqn. (4711) and the divergence of Eqn. (4712), you can obtain two equations in terms of p a and u a as dependent variables. For incompressible flows, (that is, ∇⋅ v ¯ = 0 ) and combining the two equations, a single equation is obtained in terms of acoustic pressure and noise sources from incompressible flow:

Figure 3. EQUATION_DISPLAY
1c22pat2+2v¯c2pat+(v¯)c2(v¯pa)-2pa=-(ρ¯c22Φpt2+2(v¯)c2ρ¯Φpt+(v¯)c2(v¯Φp))
(4713)

An equation for a wave caused mainly by convection effects is derived from Eqn. (4713) by assuming that, for noise sources from incompressible flows [887], ρ ¯ Φ p t P t and Φ p 1 ρ ¯ P , where P is the hydrodynamic pressure fluctuation. In this equation, a physical damping mechanism is necessary to eliminate spurious waves that originate from mesh-coarsening transitions. From the concept of wave propagation in a viscous medium, the final equation with the physical damping term is:

Figure 4. EQUATION_DISPLAY
1 c 2 2 p a t 2 + 2 v ¯ c 2 p a t + ( v ¯ ) c 2 ( v ¯ p a ) - 2 ( p a + τ p a t ) = - ( 1 c 2 2 P t 2 + 2 ( v ¯ ) c 2 P t + ( v ¯ ) c 2 ( v ¯ P ) )
(4714)
where, in the physical damping term, τ=χΔtπλ. In this term,
  • χ is the damping coefficient (= 0 for no damping and = 1 for maximum damping)
  • Δt is the time-step
  • λ=cΔtΔx is the local CFL number (where Δx is the grid spacing)

Acoustic waves are damped in poorly resolved zones (coarse mesh) using this damping coefficient to suppress undesired oscillations that pollute predictions inside the region of interest.

In the absence of mean flow, Eqn. (4714) reduces to

Figure 5. EQUATION_DISPLAY
1c22pat2-2(pa+τpat)=-1c22Pt2
(4715)

This equation resembles Lighthill's equation except that this one is based on noise sources coming from acoustic perturbation equations for incompressible flow.

Low-Pass Time Filters

The sources of noise in the acoustic wave model come mainly from the second derivative of the flow pressure fluctuations with respect to time. Due to mesh size transitions, these sources include high-frequency spurious numerical signals which, in turn, generate high-frequency noise. A suitable low-pass filter suppresses this undesired noise.

For the following filters, the higher the order of the filter, the more signal damping it provides, while also introducing more phase error (that is, the shift in the angle of the wave from that which is expected). You can consider phase error as a measure of the distortion in the signal that is introduced by phase differences for different frequencies.

The Acoustic Wave model applies the low-pass time filter directly to the APE sources. The filtered APE source is:

-1c22t2P˜=1c22pat2-(pa+τpat)
First-Order IIR Low-Pass Time Filter
The filtered form of d 2 P d t 2 at time-step n is:
Figure 6. EQUATION_DISPLAY
( d 2 P d t 2 ) ˜ n = α ( d 2 P d t 2 ) n + ( 1 α ) ( d 2 P d t 2 ) ˜ n 1
(4716)

where:

α = 2 π Δ t f c u t 2 π Δ t f c u t + 1

so that the filtered value ( d 2 P d t 2 ) ˜ at a given time-step depends on the filtered value at the previous time-step.

Second-Order Butterworth Low-Pass Time Filter
The filtered form of d 2 P d t 2 at time-step n is:
Figure 7. EQUATION_DISPLAY
( d 2 P d t 2 ) ˜ n = [ n 0 d 0 ( d 2 P d t 2 ) n + n 1 d 0 ( d 2 P d t 2 ) n 1 + n 2 d 0 ( d 2 P d t 2 ) n 2 ] + [ d 1 d 0 ( d 2 P d t 2 ) ˜ n 1 d 2 d 0 ( d 2 P d t 2 ) ˜ n 2 ]
(4717)

where:

  • n 0 = 1 , n 1 = 2 , and n 2 = 1
  • d 0 = e 2 + 2 e + 1
  • d 1 = 2 ( e 2 1 )
  • d 2 = e 2 2 e + 1
  • e = 1 tan ( 2 π Δ t f c u t 2 )
Third-Order Butterworth Low-Pass Time Filter
The filtered form of d 2 P d t 2 at time-step n is:
Figure 8. EQUATION_DISPLAY
( d 2 P d t 2 ) ˜ n = [ n 0 d 0 ( d 2 P d t 2 ) n + n 1 d 0 ( d 2 P d t 2 ) n 1 + n 2 d 0 ( d 2 P d t 2 ) n 2 + n 3 d 0 ( d 2 P d t 2 ) n 3 ] + [ d 1 d 0 ( d 2 P d t 2 ) ˜ n 1 d 2 d 0 ( d 2 P d t 2 ) ˜ n 2 d 3 d 0 ( d 2 P d t 2 ) ˜ n 3 ]
(4718)

where:

  • n 0 = 1 , n 1 = 3 , n 2 = 3 , and n 3 = 1
  • d 0 = e 3 + 2 e 2 + 2 e + 1
  • d 1 = 3 e 3 2 e 2 + 2 e + 3
  • d 2 = 3 e 3 2 e 2 2 e + 3
  • d 3 = e 3 + 2 e 2 2 e + 1
  • e = 1 tan ( 2 π Δ t f c u t 2 )

Non-Reflective Boundary Condition

The non-reflective boundary condition in the Acoustic Wave model allows acoustic waves to leave the domain through boundary without any spurious reflections. Assuming no source at the boundary and applying the operator " ∇⋅ " on the momentum equation Eqn. (4712):

Figure 9. EQUATION_DISPLAY
∇⋅ u a t + ( v ¯ ) ∇⋅ u a + 1 ρ ¯ ∇⋅ p a = 0 ∇⋅ u a = 1 ρ ¯ c 2 ( p a t + v ¯ p a )
(4719)

The acoustic pressure is related to the normal component of the acoustic velocity:

Figure 10. EQUATION_DISPLAY
p a = ρ ¯ c u a n
(4720)

Taking the time derivative of Eqn. (4720) and using Eqn. (4719), the gradient of the acoustic pressure then becomes:

Figure 11. EQUATION_DISPLAY
p a A f = ( 1 v ¯ n / c ) p a ( 1 v ¯ 2 / c 2 ) c t A f
(4721)

where A f is the face normal area and A f is its magnitude.

Newmark Alpha Method

The Newmark Alpha method starts with the following expression for time derivatives of acoustic pressure:

M ( 2 p a t 2 ) n + 1 + C ( p a t ) n + 1 + K ( p a ) n + 1 = F n + 1

where M, C, and K are operators:

  • M=1c2VdV is the operator for mass.
  • C = 1 c 2 s v ¯ d s is the operator for damping.
  • K = s ∇⋅ d s + 1 c 2 ( v ¯ ) v ¯ d s is the operator for stiffness.
  • F is the noise source term.
  • n is the previous time-step.
  • n + 1 is the time-step for which the solution is being computed.

The method then discretizes the above equation and introduces the parameter α to obtain the following modified governing equation:

Figure 12. EQUATION_DISPLAY
M ( 2 p a t 2 ) n + 1 + ( 1 + α ) C ( p a t ) n + 1 + ( 1 + α ) K ( p a ) n + 1 = ( 1 + α ) F n + 1 α F n + α C ( p a t ) n + α K ( p a ) n
(4722)

The operators and the external force take the form of matrices, where:

  • M is the mass matrix
  • C is the damping matrix
  • K is the stiffness matrix
  • F is the external force matrix
  • α is a weighting parameter, 0.33 α 0 .

APE Fields for the Post FW-H Model

The Acoustic Wave model can be combined with the Ffowcs Williams-Hawkings model to calculate the following fields for far-field cases:

  • Acoustic Density ρ a :
    Figure 13. EQUATION_DISPLAY
    ρ a = p a c 2 + ρ f
    (4723)
  • Acoustic Velocity u a :

    u a at the nth time-step, u n a , is computed from the acoustic velocities of the previous time-step and the acoustic pressure gradient. This is obtained from second-order backward differencing of the momentum equation of the Acoustic Perturbation Equations.

    Figure 14. EQUATION_DISPLAY
    u n a = 1 3 [ 4 u n 1 a u n 2 a 2 Δ t p a ρ 0 ]
    (4724)
  • APE Total Density Σ ρ :
    Figure 15. EQUATION_DISPLAY
    Σ ρ = P a c 2 + ρ f
    (4725)
  • APE Total Velocity Σ v :
    Figure 16. EQUATION_DISPLAY
    Σ v = v a + v f
    (4726)
  • APE Total Pressure Σ P :
    Figure 17. EQUATION_DISPLAY
    Σ P = P a + P f
    (4727)

where:

  • c is the speed of sound.
  • ρf is the density of the incompressible flow.
  • P a is the acoustic pressure.
  • Pf is the pressure of the incompressible flow.
  • vf is the velocity of the incompressible flow.

Smoothing Algorithm for the Acoustic Pressure Reconstruction Gradient

The reconstructed gradient of acoustic pressure is used to calculate the acoustic pressure at the face centroids. This reconstructed gradient can be smoothed out, eliminating local spikes, to assist convergence. The smoothing algorithm uses the following steps:

  1. Compute the locally averaged normalized and smoothed gradient ( p c a ) ¯ :
    Figure 18. EQUATION_DISPLAY
    ( p c a ) ¯ = ( p c a ) ( p c a ) 2 + k N B c ( p k a ) ( p k a ) 2 1 ( p c a ) 2 + k N B c 1 ( p k a ) 2
    (4728)
    where N B c is the set of those cells that are direct neighbors, through faces, of cell c .
  2. Copy the smoothed gradient ( p c a ) ¯ into the working gradient ( p c a ) .
  3. Repeat steps 1 and 2 as many times as needed to eliminate local spikes.