Preprint
Article

This version is not peer-reviewed.

Temporal and Spatial Coupling Methods for the Efficient Modelling of Dynamic Solids

A peer-reviewed article of this preprint also exists.

Submitted:

05 February 2025

Posted:

05 February 2025

You are already at the latest version

Abstract
This paper presents efficient coupling methods that accurately reduce the computational cost for modelling solids dynamically with finite elements. A multi-time step integration algorithm is developed to leverage varying time steps throughout a domain. Interfaces between subdomains are resolved explicitly with the continuity of acceleration and tractions. A spatial coupling method is combined with multiple time steps, allowing for meshes that do not necessarily conform at their interfaces. The method avoids solving additional degrees of freedom at these interfaces, with parameter-free coupling operators defined between meshes. A speedup >12X is achieved in comparison to reference single time step methods.
Keywords: 
;  ;  

1. Introduction

The temporal and spatial discretisation of structural dynamic problems is directly related to the accuracy and computational cost of the explicit finite element method. Constrained by the Courant-Friedrichs-Lewy (CFL) condition, the critical time step, Δ t C is proportional to the element size, and inversely to the dilatational wave speed [1]. This leads to simulations being restricted to min { Δ t } of the element with the smallest size or highest wave speed. Initially referred to as subcycling, pioneering works allowed for the integration of multiple time steps in a single domain [2,3]. The coupling of various kinematic fields was explored, along with the stability of such algorithms [4,5]. Asynchronous variational integration is briefly mentioned as an alternative; that discretise the functional instead of the equations of motion, with varying time steps [6]. The main drawback being the high complexity of its implementation. The importance of varying, non-integer and large time step ratios was also extended to, with heterogeneous asynchronous time integration [7,8]. However, maintaining the continuity of kinematics at the interface remains a challenge, especially for all three fields [9]. In recent works, energy conserving methods have been developed, however they depart far from the CFL condition to resolve the interface conditions at consistent time steps [10]. Spatially, non-matching mesh algorithms facilitate more flexible geometric modelling [11]. Nitsche’s method has shown to weakly enforce conditions on the interfaces of non-matching meshes without additional unknowns, but commonly suffers from the sensitivity to parameters [12,13,14,15]. Following similar principles of weak continuity, Lagrange multipliers are called upon in the mortar-based methods [16,17,18,19,20]. These types of methods have proven to be very robust, however struggle to fulfil the inf-sup stability condition, and incur a large computational cost with mapping master and slave nodes [21]. In comparison, the use of localised Lagrange multipliers, introduces a frame that independently enforces compatibility constraints on each boundary [22,23,24,25,26,27]. However, as common with other methods that introduce an additional discretised interface, the construction of this interface is neither trivial or computationally cheap [28,29,30,31]. This brief review justifies the need for more efficient couplings; both temporally and spatially. Coupling algorithms that allow for varying time step ratios, whilst stepping close to the CFL condition, concertedly those that solve for non-matching meshes, without increasing the degrees of freedom, remain a hot topic of research.

2. Governing Equations of Dynamic Solids

The problem of a solid body subject to impact, is described through the partitioning of a domain as illustrated in Figure 1. The deformation is governed by the momentum balance equation acting on solid domain Ω :
ρ u ¨ = · σ + ρ b , in Ω × [ 0 , T ]
where ρ , u ¨ , σ and b denote the density, acceleration field, stress tensor and body forces. Deformation is described at time t [ 0 , T ] for a specified constant T > 0 . Updated Lagrangian formulations of a single body are found in the following [32,33,34], here we extend this to a partitioned formulation to solve multiple solid subdomains.
Defining multiple subdomains, we state B is a solid body in an open region Ω R 3 , with its boundary denoted 𝜕 Ω . Ω is partitioned into S non-overlapping subdomains:
Ω = i = 1 S Ω i and Ω i Ω j = for i j
Starting from the simplest case, S = 2 , for a two-subdomain partitioning, where Ω L and Ω s represent the large and small subdomains. The boundary between the two is defined Γ , where for matching conditions we enforce:
u ¨ L = u ¨ s on Γ
t L = t s on Γ
to ensure the continuity of acceleration u ¨ and tractions t , as well as enforcing Dirichlet and Neumann boundary conditions. The variational formulation of the dynamic equilibrium in Equation 1 can be described for both Ω L and Ω s as the following:
Ω L ρ L u ¨ L · δ u ˙ d Ω = Γ L t L · δ u ˙ d Γ Ω L σ L : δ D L d Ω + Ω L ρ L b L · δ u ˙ d Ω
Ω s ρ s u ¨ s · δ u ˙ d Ω = Γ s t s · δ u ˙ d Γ Ω s σ s : δ D s d Ω + Ω s ρ s b s · δ u ˙ d Ω
where we denote a variational velocity δ u ˙ V 0 , in a space V 0 where δ u ˙ H 1 ( Ω i ) , and D as rate of deformation. A discrete approximation of the variational form can be reduced to the ordinary differential equations:
M L u ¨ L = f L ext f L int ; M s u ¨ s = f s ext f s int
where for subdomains Ω L and Ω s , we sum over a number of finite elements, N L and N s , in each subdomain:
M L = e = 1 N L Ω e ρ L N T N d Ω e ; M s = e = 1 N s Ω e ρ s N T N d Ω e
f L ext = e = 1 N L Ω e N T t L d Ω e ; f s ext = e = 1 N s Ω e N T t s d Ω e
f L int = e = 1 N L Ω e B T σ L d Ω e f s int = e = 1 N s Ω e B T σ s d Ω e
The Lagrangian shape functions are represented by N , with their derivatives denoted B . As common within the explicit finite element method, M is lumped for each subdomain, with f ext and f int both computed with vectors too. We elect to use the leapfrog time integration scheme to step through time, staggering the solution of each kinematic quantity such that:
u ¨ L n = M L 1 ( f L ext f L int ) ; u ¨ s n = M s 1 ( f s ext f s int )
u ˙ L n + 1 / 2 = u ˙ L n 1 / 2 + u ¨ L n · Δ t L ; u ˙ s n + 1 / 2 = u ˙ s n 1 / 2 + u ¨ s n · Δ t s
u L n + 1 = u L n + u ˙ L n + 1 / 2 · Δ t L ; u s n + 1 = u s n + u ˙ s n + 1 / 2 · Δ t s
noting that a diagonal mass matrix allows for a direct computation of acceleration. Velocity u ˙ is computed on the half time step, with displacement u found each full time step. Next we summarise the temporal coupling, enabled by multi-time step (MTS) integration.

3. Multi-Time Step Integration

Multi-time stepping enables partitioned subdomains Ω L and Ω s to integrate with Δ t L and Δ t s , respectively. However, to allow for this difference in time steps, special attention must be given to the solution of the interface Γ . Crucially, the conditional stability of explicit methods require an element’s time step to obey the CFL condition for a linear undamped system:
Δ t C = 2 ω C min e h e c e
Here we represent Δ t C as the critical time step, ω C as the maximum eigenfrequency, h e as the characteristic length of an element, and c e the dilatational (longitudinal) wave speed.

3.1. Salient Multi-Time Stepping Features

The asynchronous integration is enabled with three important groups of computations. The first being the explicit computation of the acceleration on the interface Γ :
M Γ = ( C s T M s C s ) + ( C L T M L C L )
f Γ int = C s T f s int + C L T f L int ; f Γ ext = C s T f s ext + C L T f L ext
We define indicator matrices (vectors in 1-D) for each subdomain C to identify the degrees of freedom on the interface of subdomains. These summations provide the ingredients for computing the interface acceleration as:
u ¨ Γ = M Γ 1 ( f Γ ext f Γ int )
where we compute u ¨ Γ at each large time step Δ t L . The integration of the subdomains is controlled by the definition of the time step ratios. Suppose the two subdomains begin at a similar point in time t L N = t s n where N and n are the small and large steps respectively. The time after the maximum stable integration step on each subdomain is referred to as the trial time  t T , such that:
t T L N + 1 = t L + Δ t C L ; t T s n + k = t s + Δ t C s
where for every Δ t L , the number of small time steps k elapse since the last point in time where subdomains are equal in time. Now we can define the current time step ratio, t r a t i o n + k , and next time step ratio, t r a t i o n + k + 1 for the advancement of Ω s with:
t r a t i o n + k = t s n + k t L N t T L N + 1 t L N ; t r a t i o n + k + 1 = ( t s n + k + Δ t s n + k ) t L N t T L N + 1 t L N
Starting from each common time step with the integration of Ω s , the number of small time steps Δ t s is determined by the evaluation of time step ratios t r a t i o n + k and t r a t i o n + k + 1 . If the condition of t r a t i o n + k + 1 1 or ( t r a t i o n + k 1 and t r a t i o n + k + 1 1 ) is satisfied, further steps on Δ t s can proceed before integrating Ω L over Δ t L . As a consequence of subdomains integrating over their own respective time step, we ensure that the proposed method still finds a common time between all subdomains. Following the small trial time t T s exceeding the large trial time t T L , the method proceeds to compute two additional ratios α L and α s . These denote the reduction factors required to maintain the subdomains in synchronisation where 0 α 1 . We compute:
α L = 1 ( t T L N t s n + k ) ( t T L N + 1 t L N ) ; α s = 1 ( t T s n + k t T L N + 1 ) ( t T s n + k + 1 t s n + k )
Through computing α on both subdomains, we can compare reduction factors, such that:
t L N + 1 = t s n + k = t s n + k = 0 k 1 Δ t C s n + k + α s · Δ t C s n + k , α s > α L t s n + α L · Δ t C L N , α L α s
where we look to reduce the time step of the subdomain closest to CFL condition. In the following section we summarise the multi-time stepping algorithm, with each of these key features, as well as its implementation.

3.2. Summary of Temporal Algorithm

We provide an overview of the method required to integrate Ω L and Ω s with Δ t L and Δ t s . It shows a single large step N, exemplifying each of the features mentioned above. A note that T O L = 1 e-6 is used for when Δ t L Δ t s , and computation of M Γ in Equation 15 is only required at t = 0 for a mass-conserving problem.
Algorithm 1 Summary of Algorithm for Coupling in Time from N to N + 1
  1:
procedure a two-subdomain multi time integration step
  2:
    while  t r a t i o n + k + 1 1 or ( t r a t i o n + k 1 and t r a t i o n + k + 1 1 + TOL ) do
  3:
        Integrate subdomain Ω s with u ¨ Γ and compute force vectors f s int , f s ext over Δ t s
  4:
        Compute trial times t T s n + k , t T L N + 1 and time step ratios t r a t i o n + k , t r a t i o n + k + 1
  5:
    Compute time step reduction factors α L , α s
  6:
    if  α L α s  then
  7:
         Δ t L = α L · Δ t L
  8:
    else
  9:
         Δ t s = α s · Δ t s
10:
        Integrate subdomain Ω s with u ¨ Γ and recompute force vectors f s int , f s ext over Δ t s
11:
        Recompute trial times t T s n + k , t T L N + 1 and time step ratios t r a t i o n + k , t r a t i o n + k + 1
12:
    Integrate subdomain Ω L with u ¨ Γ and compute force vectors f L int , f L ext over Δ t L
13:
    Compute interface acceleration u ¨ Γ with Eqs. 15 - 17 for next time step
14:
    Recompute trial times t T s n + k , t T L N + 1 and time step ratios t r a t i o n + k , t r a t i o n + k + 1
The proposed method is implemented in an open-source python code, found in the following repository https://github.com/kinfungchan/multi-time-step-integration. It contains re-implementations of methods from literature for the two-subdomain case [9,10]. Whilst we depict the case of just two subdomains, the algorithm can be extended to multiple by processing subdomains as pairs as shown in [35].

3.3. Numerical Examples in Time

We present a numerical example in 1-D, with the elastic wave propagation through a heterogeneous bar. Suppose the domain Ω is split into two subdomains Ω L and Ω s of similar discretisation, with isotropic elastic properties of E L = 207 GPa, E s = 1000 GPa and ρ L = ρ s = 7.83 × 10 6 kgmm 3 . These material properties result in a non-integer m = 2.19 , where the time step ratio is solely driven by the dissimilar material properties. Figure 2 depicts the bar configuration. The velocity boundary condition is applied to Ω L at x = 0 with u ˙ ( t ) = 0.01 sin ( 2 π ω L t ) ms 1 where we define a half sine wave with a frequency of ω L = ( 125 ( ( 7.83 × 10 6 ) / 207 ) ) 1 rads 1 . The difference in material impedance results in a portion of the incident wave being transmitted and the remainder reflected in the opposite direction.
In Figure 3, a comparison between the coupled solution ( Ω L with Ω s ) and the monolithic (single time step) solution is presented at four separate time stamps. The multi-time step solution solves u ˙ L and u ˙ s over Δ t L and Δ t s , whereas u ˙ m o n o is limited by Δ t s . Consequently, for m = 2.19 , our method reduces the number of integration steps on Ω L by half. From prescription of the full wave at t 1 , through to the transmission and reflection of the wave at t 4 , the MTS solution aligns very well with the single time step solution, despite the halving the number of large time steps. This reduction in computational effort is even more prominent for highly heterogeneous configurations, as well as variance in spatial discretisation.
For the above simulation we also compute the energy components of each subdomain with the following:
W ext n + 1 = W ext n + Δ t i n + 1 / 2 2 ( u ˙ i n + 1 / 2 ) T ( f ext n + f ext n + 1 ) = W ext n + 1 2 Δ u i T ( f ext n + f ext n + 1 )
W int n + 1 = W int n + Δ t i n + 1 / 2 2 ( u ˙ i n + 1 / 2 ) T ( f int n + f int n + 1 ) = W int n + 1 2 Δ u i T ( f int n + f int n + 1 )
W kin n = 1 2 ( u ˙ i n + 1 / 2 ) T M u ˙ i n + 1 / 2
where n can be interchanged with N when evaluating Ω L . The balance of energy can be evaluated in a similar way to the works of Neal and Belytschko [3], with the following:
| W ext W int + W kin | | | W b a l | |
In Figure 4 we show each of the components of energy and its overall balance. For both monolithic and multi-time step solutions a smooth transition of energy is observed as the wave interacts with Γ . Remarkably, as the temporal coupling is enforced, the W b a l for both Ω L and Ω s is of the order 1 × 10 13 kNmm, significantly below each of the components at 1 × 10 8 kNmm. This numerical example captures the propagation of a smooth pulse, however severe loading cases, as well as a 3-D problems, remain ongoing work.

4. Solving Non-Matching Meshes

The problem of non-matching meshes is commonly found when simulating the dynamical behaviour of solids. We present an algorithm, combined with multi-time stepping, that relaxes the constraint of these conforming nodes, allowing for a coarser representation of a subdomain to be utilised; hence reducing the computational overhead.

4.1. Combined Spatial and Temporal Coupling

The following section follows on from governing equations defined in Section 2, however we now allow for the non-overlapping interface Γ = Γ L Γ s to consist of two separate spatial discretisations. Their compatibility is maintained such that:
u ¨ Γ L ( C L x L ) = u ¨ Γ s ( C s x L ) = u ¨ Γ ( x Γ )
t Γ L ( C L x L ) = t Γ s ( C s x s ) = t Γ ( x Γ )
where positions use incidence C matrix, such that C L x L Γ L and C s x s Γ s for each subdomain, and externally assembled interface contains x Γ Γ to describe the common boundary between the subdomains. The total virtual power can be summated for two subdomains to give δ P = δ P L + δ P s + δ P Γ , where a general form is obtained:
δ P = δ u ˙ L T { f L int f L ext + M L u ¨ L + N L T f Γ L } + δ u ˙ s T { f s int f s ext + M s u ¨ s + N s T f Γ s } + δ f Γ L T { N L T u ˙ Γ L L L T u ˙ Γ } + δ f Γ s T { N s T u ˙ Γ s L s T u ˙ Γ } δ u ˙ Γ T { N L T f Γ L + N s T f Γ s }
where variation in velocity coupling force on the interface u ˙ and f Γ i are accounted for. N i T and L i are interpolation (or prolongation), and incidence operators ( Γ to Ω i ), respectively. To map to the interface we describe this spatial coupling operator N i in more detail:
N i R N Γ i × N Γ
with dimensions determined by N Γ i and N Γ ; as the number of nodes on the interface of the subdomain Ω i , and the number of nodes on the interface Γ , respectively. Therefore, N Γ interpolates using Lagrangian shape functions for the two subdomains Ω L and Ω s as:
N Γ ( x ) = δ ( x Γ x Γ i ) , for i = L , s
where δ is viewed as a dirac Delta function for coincident nodes. It is convenient to define a restriction operator R i R N Γ × N Γ i as the transpose of N i , to map both forces and mass from subdomain interfaces Γ L and Γ s onto Γ . The summation on the interfaces now become:
M Γ = R L C L T M L + R s C s T M s = R L M Γ L + R s M Γ s
f Γ int = R L C L T f L int + R s C s T f s int = R L f Γ L int + R s f Γ s int
f Γ ext = R L C L T f L ext + R s C s T f s ext = R L f Γ L ext + R s f Γ s ext
where we compute mass M Γ , internal force f Γ int and external force f Γ ext to allow for the explicit computation of u ¨ Γ in Equation 17 to be recalled. These operators are analogous to concepts in multigrid methods and localised Lagrange multipliers (LLMs) [36,37]. Subsequently, we map u ¨ Γ from Γ back to the subdomains:
u ¨ Γ L = N L u ¨ Γ ; u ¨ Γ s = N s u ¨ Γ
We illustrate a non-matching mesh in Figure 5 and compute its operators through exemplifying a linear isoparametric mapping in 2-D, where Γ is discretised with line elements to depict the simplicity of this coupling.
For the interpolation matrix, we elucidate that from Γ to Γ L the mapping is simply one-to-one and N L will always take the form of an identity matrix Ω L , whereas N s requires computation of the shape functions:
N L = 1 0 0 0 1 0 0 0 1 ; N s = 1 0 0 1 / 3 2 / 3 0 0 2 / 3 1 / 3 0 0 1 ; R L = N L T ; R s = N s T
where, for this simple case, it can also be shown that the restriction is the transpose of the interpolation. The interface Γ is assumed to share the same geometrical description on both subdomain interfaces Γ L and Γ s , without overlap or separation. The spatial and temporal methods are combined to give the following algorithm:
Algorithm 2 Summary of Non-Matching Mesh Algorithm with Multi-Time Stepping
  1:
procedure integrate a two-domain non-matching mesh with MTS
  2:
    while  t r a t i o n + k + 1 1 or ( t r a t i o n + k 1 and t r a t i o n + k + 1 1 + T O L ) do
  3:
        Compute u ¨ Γ s with operator N s in Eq. 34 on Γ s
  4:
        Integrate small domain Ω s and compute vectors f s int , f s ext
  5:
        Compute trial times t T s n + k , t T L N + 1 and time step ratios t r a t i o n + k , t r a t i o n + k + 1
  6:
    Compute time step reduction factors α L , α s
  7:
    if  α L α s  then
  8:
         Δ t L = α L · Δ t L
  9:
    else
10:
         Δ t s = α s · Δ t s
11:
        Compute u ¨ Γ s with operator N s in Eq. 34 on Γ s
12:
        Integrate small domain Ω s and compute vectors f s int , f s ext
13:
        Recompute trial times t T s n + k , t T L N + 1 and time step ratios t r a t i o n + k , t r a t i o n + k + 1
14:
    Compute u ¨ Γ L with operator N L in Eq. 34 on Γ L
15:
    Integrate large domain Ω L and compute vectors f L int , f L ext
16:
    Summate kinetics with R L , R s , C L , C s to find M Γ , f Γ int and f Γ ext with Eq. 31 - 33
17:
    Compute trial times t T s n + k , t T L N + 1 and time step ratios t r a t i o n + k , t r a t i o n + k + 1

4.2. Numerical Examples in Space and Time

The following numerical study looks to represent the stress gradients prior to fracture in a compact-tension (CT) specimen test, utilising a similar geometry from literature [38,39]. Figure 6 (a) portrays the geometry modelled in the following example. As the specimen is loaded, stress concentrates about the specimen’s crack tip. We apply a ramped velocity u ˙ ( t ) boundary condition on nodes that create a semicircle for upper and lower pins, as shown in Figure 6 (b), with a maximum magnitude of 0.2 ms 1 . Whilst equivalent velocities are applied to each of the nodes in the pins, to replicate the contact pressure on the pins, methods such as those applied by Triclot et al. should be considered [40]. Material properties are similar to alumina with E = 370 GPa, ρ = 3.9 × 10 6 kgmm 3 and Poisson’s ratio ν = 0.22 . We model the CT specimen with three simulations; one using a fine mesh throughout the entire domain, one coupling a coarse Ω L and fine Ω s mesh with a single Δ t , and another with Ω L and Ω s integrating with multiple time steps Δ t L and Δ t s , respectively. Structured meshes are used in all cases where an element size of 0.58 mm for fine and 1 mm for coarse. All simulations use C o = 0.5 , running for a maximum t f i n a l = 0.02 ms.
In Figure 7 and Figure 8 we plot the stress contours σ y y at t = 0.01408 ms and t = 0.01966 ms, respectively where the stress concentration can be visualised at the crack tip of the specimen. Figure 7 (a) and Figure 8 (a) capture the reference mesh, whilst Figure 7 (b) and Figure 8 (b) capture the spatially coupled mesh on a single time step Δ t s . Figure 8 accurately predicts maximum stresses of 0.0396 GPa vs 0.0410 GPa for reference against non-matching mesh.
Through combining spatial and temporal coupling, we observe similar ( < 1 × 10 6 GPa) results in σ y y distribution, as seen in (a) of Figure 9. The difference in the coupled simulations is captured via the (b) of Figure 9, where the root mean square error (RMSE) is plotted. The stress σ y y is linear interpolated for the non-matching mesh, to allow for comparison of stress on the coarse mesh’s Gauss points. The couplings capture nearly the entire specimen within a < 5 % error. Considerable error is located around the circumference of the pins, and the far right of the specimen, however these Gauss points reside far from the area of interest at the crack tip. To avoid such errors, a smaller element size would be required in Ω L , however this raises the trade-off between accuracy and computational efficiency. Considerable speedup is achieved, with both couplings, as presented in Table 9.
Figure 9. Comparison of σ y y for: (a) - combined spatial and temporal coupling (multi-time stepping); (b) - RMSE Error of σ y y for dynamically loaded compact-tension specimen at t = 0.01966 ms.
Figure 9. Comparison of σ y y for: (a) - combined spatial and temporal coupling (multi-time stepping); (b) - RMSE Error of σ y y for dynamically loaded compact-tension specimen at t = 0.01966 ms.
Preprints 148362 g009
Table 1. Computational runtime in seconds and speedup vs reference, of the dynamically loaded compact-tension specimen.
Table 1. Computational runtime in seconds and speedup vs reference, of the dynamically loaded compact-tension specimen.
Simulation Runtime [s] Speedup
Reference (monolithic) 7428 -
Spatially Coupled 2267 3.27×
Spatially and Temporally Coupled 572 12.98×

5. Conclusions

We present coupling methods for the dynamic modelling of solids with explicit finite elements; temporally and spatially. When modelling composites, constituents have varying dilatational wave speeds, hence different time steps. Integrating over the smallest time step can prove highly inefficient, hence the need for multi-time stepping. Our method allows partitions of a domain to solve with their own respective time step, hence reducing computational overhead. Stability of the method is assessed through evaluation of the subdomains’ energies. The addition of the coupling in space solves the issue of non-matching meshes, so that small element sizes are only required in regions of interest. Coupling operators are easily implemented, without increasing the degrees of freedom on the interface. Ongoing work addresses the spatial coupling with a quadrilateral non-matching interfaces in 3-D domains [41]. Numerical examples capture an increase in efficiency with stress wave propagation in a heterogeneous bar, and the modelling of a compact-tension specimen. Both couplings in time and space reduce computational runtimes, when compared to their monolithic simulation, especially when combined. Future work looks at the coupling between macro and meso- scale meshes [42,43,44], with adaptivity a clear necessity for these multi-scale couplings [45]. Other coupling opportunities are plentiful when considering dynamic applications; the modelling of contact [14,16], composite fracture [38,39], fluid-structure interaction [13,27], and other impact engineering scenarios are just a few to mention.

Funding

This research was funded the Engineering and Physical Sciences Research Council (EPSRC) and Rolls-Royce’s ASiMoV Prosperity Partnership with Reference EP/S005072/1.

Data Availability Statement

The data that support the findings of this study are openly available upon request. The algorithm is described for two time-domains at https://github.com/kinfungchan/multi-time-step-integration.

Conflicts of Interest

The authors declare no conflicts of interest.

References

  1. Courant, R., Friedrichs, K. and Lewy, H., On the partial difference equations of mathematical physics. IBM journal of Research and Development 1967, 11(2), 215–234. [CrossRef]
  2. Hughes, T.J. and Liu, W.K., Implicit-explicit finite elements in transient analysis: Implementation and numerical examples. Journal of Applied Mechanics, Transactions ASME 1978, 45(2), 375–378. [CrossRef]
  3. Neal, M.O. and Belytschko, T., Explicit-explicit subcycling with non-integer time step ratios for structural dynamic systems. Computers & Structures 1989, 31(6), 871–880. [CrossRef]
  4. Daniel, W.J.T., Analysis and implementation of a new constant acceleration subcycling algorithm. International Journal for Numerical Methods in Engineering 1997, 40(15), 2841–2855.
  5. Daniel, W.J.T., A partial velocity approach to subcycling structural dynamics. Computer methods in applied mechanics and engineering 2003, 192(3-4), 375–394. [CrossRef]
  6. Lew, A., Marsden, J.E., Ortiz, M. and West, M., Variational time integrators. International Journal for Numerical Methods in Engineering 2004, 60(1), 153–212. [CrossRef]
  7. Combescure, A. and Gravouil, A., A numerical scheme to couple subdomains with different time-steps for predominantly linear transient analysis. Computer methods in applied mechanics and engineering 2002, 191(11-12), 1129–1157. [CrossRef]
  8. Gravouil, A., Combescure, A. and Brun, M., Heterogeneous asynchronous time integrators for computational structural dynamics. International Journal for Numerical Methods in Engineering 2015, 102(3-4), 202–232. [CrossRef]
  9. Cho, S.S., Kolman, R., González, J.A. and Park, K.C., Explicit multistep time integration for discontinuous elastic stress wave propagation in heterogeneous solids. International Journal for Numerical Methods in Engineering 2019, 118(5), 276–302. [CrossRef]
  10. Dvořák, R., Kolman, R., Mračko, M., Kopačka, J., Fíla, T., Jiroušek, O., Falta, J., Neuhäuserová, M., Rada, V., Adámek, V. and González, J.A., Energy-conserving interface dynamics with asynchronous direct time integration employing arbitrary time steps. Computer Methods in Applied Mechanics and Engineering 2023, 413, 116110. [CrossRef]
  11. de Boer, A., van Zuijlen, A.H. and Bijl, H., Review of coupling methods for non-matching meshes. Computer methods in applied mechanics and engineering 2007, 196(8), 1515–1525. [CrossRef]
  12. Hansbo, A. and Hansbo, P., An unfitted finite element method, based on Nitsche’s method, for elliptic interface problems. Computer methods in applied mechanics and engineering 2002, 191(47-48), 5537–5552. [CrossRef]
  13. Hansbo, A. and Hansbo, P., Nitsche’s method for coupling non-matching meshes in fluid-structure vibration problems. Computational Mechanics 2002, 32, 134–139. [CrossRef]
  14. Wriggers, P. and Zavarise, G., A formulation for frictionless contact problems using a weak form introduced by Nitsche. Computational Mechanics 2017, 41, 407–420. [CrossRef]
  15. Sanders, J.D., Laursen, T.A. and Puso, M.A., A Nitsche embedded mesh method. Computational Mechanics 2010, 49, 243–257. [CrossRef]
  16. Puso, M.A. and Laursen, T.A., A mortar segment-to-segment contact method for large deformation solid mechanics. Computer methods in applied mechanics and engineering 2004, 193(6-8), 601–629. [CrossRef]
  17. Faucher, V. and Combescure, A., A time and space mortar method for coupling linear modal subdomains and non-linear subdomains in explicit structural dynamics. Computer methods in applied mechanics and engineering 2003, 192(5-6), 509–533. [CrossRef]
  18. Steinbrecher, I., Mayr, M., Grill, M.J., Kremheller, J., Meier, C. and Popp, A., A mortar-type finite element approach for embedding 1D beams into 3D solid volumes. Computational Mechanics 2020, 66, 1377–1398. [CrossRef]
  19. Zhou, M., Zhang, B., Chen, T., Peng, C. and Fang, H., A three-field dual mortar method for elastic problems with nonconforming mesh. Computer Methods in Applied Mechanics and Engineering 2020, 362, 112870. [CrossRef]
  20. Wilson, P., Teschemacher, T., Bucher, P. and Wüchner, R., Non-conforming FEM-FEM coupling approaches and their application to dynamic structural analysis. Engineering Structures 2021, 241, 112342. [CrossRef]
  21. Singer, V., Teschemacher, T., Larese, A., Wüchner, R. and Bletzinger, K.U., Lagrange multiplier imposition of non-conforming essential boundary conditions in implicit material point method. Computational Mechanics 2024, 73(6), 1311–1333. [CrossRef]
  22. Puso, M.A. and Laursen, T.A., A simple algorithm for localized construction of non-matching structural interfaces. International Journal for Numerical Methods in Engineering 2002, 53(9), 2117–2142. [CrossRef]
  23. Herry, B., Di Valentin, L. and Combescure, A., An approach to the connection between subdomains with non-matching meshes for transient mechanical analysis. International Journal for Numerical Methods in Engineering 2002, 55(8), 973–1003. [CrossRef]
  24. Subber, W. and Matouš, K., Asynchronous space–time algorithm based on a domain decomposition method for structural dynamics problems on non-matching meshes Computational Mechanics 2016, 57, 211–235. [CrossRef]
  25. González, J.A., Kolman, R., Cho, S.S., Felippa, C.A. and Park, K.C., Inverse mass matrix via the method of localized Lagrange multipliers. International Journal for Numerical Methods in Engineering 2018, 113(2), 277–295. [CrossRef]
  26. Jeong, G.E., Song, Y.U., Youn, S.K. and Park, K.C., A new approach for nonmatching interface construction by the method of localized Lagrange multipliers. Computer Methods in Applied Mechanics and Engineering 2020, 361, 112728. [CrossRef]
  27. González, J.A. and Park, K.C., Three-field partitioned analysis of fluid–structure interaction problems with a consistent interface model. Computer Methods in Applied Mechanics and Engineering 2023, 414, 116134. [CrossRef]
  28. Cho, Y.S., Jun, S., Im, S. and Kim, H.G., An improved interface element with variable nodes for non-matching finite element meshes. Computer methods in applied mechanics and engineering 2005, 194(27-29), 3022–3046. [CrossRef]
  29. Kim, H.G., Development of three-dimensional interface elements for coupling of non-matching hexahedral meshes. Computer methods in applied mechanics and engineering 2005, 197(45-48), 3870–3882. [CrossRef]
  30. Bitencourt Jr, L.A., Manzoli, O.L., Prazeres, P.G., Rodrigues, E.A. and Bittencourt, T.N., A coupling technique for non-matching finite element meshes. Computer Methods in Applied Mechanics and Engineering 2015, 290, 19–44. [CrossRef]
  31. Rodrigues, E.A., Manzoli, O.L., Bitencourt Jr, L.A., Bittencourt, T.N. and Sánchez, M., An adaptive concurrent multiscale model for concrete based on coupling finite elements. Computer methods in applied mechanics and engineering 2018, 328, 26–46. [CrossRef]
  32. Dunne, F., and Petrinic, N., Introduction to computational plasticity, OUP Oxford, 2005.
  33. de Souza Neto, E.A., Peric, D. and Owen, D.R., Computational methods for plasticity: theory and applications, John Wiley & Sons, 2011.
  34. Belytschko, T., Liu, W.K., Moran, B. and Elkhodary, K., Nonlinear finite elements for continua and structures, John Wiley & Sons, 2014.
  35. Chan, K.F., Bombace, N., Sap, D., Wason, D., Falco, S. and Petrinic, N., A Multi-Time Stepping Algorithm for the Modelling of Heterogeneous Structures With Explicit Time Integration. International Journal for Numerical Methods in Engineering 2025, 126(1), e7638. [CrossRef]
  36. Biotteau, E., Gravouil, A., Lubrecht, A.A. and Combescure, A., Multigrid solver with automatic mesh refinement for transient elastoplastic dynamic problems. International Journal for Numerical Methods in Engineering 2010, 84(8), 947–971. [CrossRef]
  37. Dvořák, R., Kolman, R. and González, J.A., On the automatic construction of interface coupling operators for non-matching meshes by optimization methods. Computer Methods in Applied Mechanics and Engineering 2024, 432, 117336. [CrossRef]
  38. Pinho, S.T., Robinson, P. and Iannucci, L., Fracture toughness of the tensile and compressive fibre failure modes in laminated composites Composites Science and Technology 2006, 66(13), 2069–2079. [CrossRef]
  39. Sommer, D.E., Thomson, D., Hoffmann, J. and Petrinic, N., Numerical modelling of quasi-static and dynamic compact tension tests for obtaining the translaminar fracture toughness of CFRP. Composites Science and Technology 2023, 237, 109997. [CrossRef]
  40. Triclot, J., Corre, T., Gravouil, A. and Lazarus, V., Key role of boundary conditions for the 2D modeling of crack propagation in linear elastic Compact Tension tests. Engineering Fracture Mechanics 2023, 277, 109012. [CrossRef]
  41. Sahu, I., Bilinear-Inverse-Mapper: Analytical Solution and Algorithm for Inverse Mapping of Bilinear Interpolation of Quadrilaterals. 2024, Available at SSRN 4790071.
  42. Falco, S., Fogell, N., Iannucci, L., Petrinic, N. and Eakins, D., A method for the generation of 3D representative models of granular based materials. International Journal for Numerical Methods in Engineering 2017, 112(4), 338–359. [CrossRef]
  43. Wason, D., A multi-scale approach to the development of high-rate-based microstructure-aware constitutive models for magnesium alloys. Doctoral dissertation, University of Oxford.
  44. Falco, S., Fogell, N., Iannucci, L., Petrinic, N. and Eakins, D., Raster approach to modelling the failure of arbitrarily inclined interfaces with structured meshes. Computational Mechanics 2024, 74, 805-–818. [CrossRef]
  45. Bombace, N., Dynamic adaptive concurrent multi-scale simulation of wave propagation in 3D media. Doctoral dissertation, University of Oxford.
Figure 1. A 3-D domain Ω decomposed into Ω L and Ω s where Γ L and Γ s are non-matching interfaces to be externally resolved on Γ . Normal vector and tractions are visualised on Ω L and Ω s respectively.
Figure 1. A 3-D domain Ω decomposed into Ω L and Ω s where Γ L and Γ s are non-matching interfaces to be externally resolved on Γ . Normal vector and tractions are visualised on Ω L and Ω s respectively.
Preprints 148362 g001
Figure 2. A one-dimensional heterogeneous domain Ω split into large subdomain Ω L and small subdomain Ω s , solved with Δ t L and Δ t s respectively, of length L L = 125 mm and L s 250 mm The problem assuming uni-axial motion with ν = 0 . A compressive half sine velocity boundary condition is applied from Ω L .
Figure 2. A one-dimensional heterogeneous domain Ω split into large subdomain Ω L and small subdomain Ω s , solved with Δ t L and Δ t s respectively, of length L L = 125 mm and L s 250 mm The problem assuming uni-axial motion with ν = 0 . A compressive half sine velocity boundary condition is applied from Ω L .
Preprints 148362 g002
Figure 3. Axial wave propagation in a heterogeneous bar: (a) - boundary condition at t 1 = 0.03363 ms and initial transmission at t 2 = 0.04424 ms of the stress wave; (b) - transmission and reflection of the stress wave at t 3 = 0.01323 ms and t 4 = 0.02920 ms.
Figure 3. Axial wave propagation in a heterogeneous bar: (a) - boundary condition at t 1 = 0.03363 ms and initial transmission at t 2 = 0.04424 ms of the stress wave; (b) - transmission and reflection of the stress wave at t 3 = 0.01323 ms and t 4 = 0.02920 ms.
Preprints 148362 g003
Figure 4. Energy balance for axial wave propagation problem: (a) - Monolithic (single Δ t m o n o ) simulation system energy component history and balance with Equations 22 - 25, (b) - Multi-time stepping ( Δ t L and Δ t s ) simulation energy balance.
Figure 4. Energy balance for axial wave propagation problem: (a) - Monolithic (single Δ t m o n o ) simulation system energy component history and balance with Equations 22 - 25, (b) - Multi-time stepping ( Δ t L and Δ t s ) simulation energy balance.
Preprints 148362 g004
Figure 5. A non-matching benchmark highlighting the interface with differently discretised subdomains partitioned with the Large Γ L , small Γ s and externally meshed interface Γ .
Figure 5. A non-matching benchmark highlighting the interface with differently discretised subdomains partitioned with the Large Γ L , small Γ s and externally meshed interface Γ .
Preprints 148362 g005
Figure 6. (a) - Diagram of compact-tension specimen with dimensions in [mm], as seen in Sommer et al. [39]; (b) - Nodal sets on the meshed subdomain Ω L for prescribed velocity boundary conditions on top (+ve loading) and bottom (-ve loading) pins.
Figure 6. (a) - Diagram of compact-tension specimen with dimensions in [mm], as seen in Sommer et al. [39]; (b) - Nodal sets on the meshed subdomain Ω L for prescribed velocity boundary conditions on top (+ve loading) and bottom (-ve loading) pins.
Preprints 148362 g006
Figure 7. Comparison of σ y y for: (a) - reference (monolithic) versus (b) - spatially coupled dynamically loaded compact-tension specimen, clipping from -0.0005 to 0.01 GPa at t = 0.01408 ms.
Figure 7. Comparison of σ y y for: (a) - reference (monolithic) versus (b) - spatially coupled dynamically loaded compact-tension specimen, clipping from -0.0005 to 0.01 GPa at t = 0.01408 ms.
Preprints 148362 g007
Figure 8. Comparison of σ y y for: (a) - reference (monolithic) versus (b) - spatially coupled dynamically loaded compact-tension specimen, clipping from -0.0005 to 0.01 GPa at t = 0.01966 ms.
Figure 8. Comparison of σ y y for: (a) - reference (monolithic) versus (b) - spatially coupled dynamically loaded compact-tension specimen, clipping from -0.0005 to 0.01 GPa at t = 0.01966 ms.
Preprints 148362 g008
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.
Copyright: This open access article is published under a Creative Commons CC BY 4.0 license, which permit the free download, distribution, and reuse, provided that the author and preprint are cited in any reuse.
Prerpints.org logo

Preprints.org is a free preprint server supported by MDPI in Basel, Switzerland.

Subscribe

Disclaimer

Terms of Use

Privacy Policy

Privacy Settings

© 2025 MDPI (Basel, Switzerland) unless otherwise stated