Solid Mechanics Solver
List of Symbols
Introduction
The SolidMechanics_LagrangianFEM solver applies a Continuous Galerkin finite element method to solve the linear momentum balance equation. The primary variable is the displacement field which is discretized at the nodes.
Theory
Governing Equations
The SolidMechanics_LagrangianFEM solves the equations of motion as given by
which is a 3-dimensional expression for the well known expression of Newtons Second Law (). These equations of motion are discretized using the Finite Element Method, which leads to a discrete set of residual equations:
Quasi-Static Time Integration
The Quasi-Static time integration option solves the equation of motion after removing the inertial term, which is expressed by
which is essentially a way to express the equation for static equilibrium (). Thus, selection of the Quasi-Static option will yield a solution where the sum of all forces at a given node is equal to zero. The resulting finite element discretized set of residual equations are expressed as
Taking the derivative of these residual equations wrt. the primary variable (displacement) yields
And finally, the expression for the residual equation and derivative are used to express a non-linear system of equations
which are solved via the solver package.
Implicit Dynamics Time Integration (Newmark Method)
For implicit dynamic time integration, we use an implementation of the classical Newmark method. This update method can be posed in terms of a simple SDOF spring/dashpot/mass model. In the following, represents the mass, represent the damping of the dashpot, represents the spring stiffness, and represents some external load.
and a series of update equations for the velocity and displacement at a point:
As intermediate quantities we can form an estimate (predictor) for the end of step displacement and midstep velocity by assuming zero end-of-step acceleration.
This gives the end of step displacement and velocity in terms of the predictor with a correction for the end step acceleration.
The acceleration and velocity may now be expressed in terms of displacement, and ultimately in terms of the incremental displacement.
plugging these into equation of motion for the SDOF system gives:
Finally, we assume Rayliegh damping for the dashpot.
Of course we know that we intend to model a system of equations with many DOF. Thus the representation for the mass, spring and dashpot can be replaced by our finite element discretized equation of motion. We may express the system in context of a nonlinear residual problem
Again, the expression for the residual equation and derivative are used to express a non-linear system of equations
which are solved via the solver package. Note that the derivatives involving and are interchangable, as are differences between the non-linear iterations.
Explicit Dynamics Time Integration (Special Implementation of Newmark Method with gamma=0.5, beta=0)
For the Newmark Method, if gamma=0.5, beta=0, and the inertial term contains a diagonalized “mass matrix”, the update equations may be carried out without the solution of a system of equations. In this case, the update equations simplify to a non-iterative update algorithm.
First the mid-step velocity and end-of-step displacements are calculated through the update equations
Then the residual equation/s are calculated, and acceleration at the end-of-step is calculated via
Note that the mass matrix must be diagonal, and damping term may not include the stiffness based damping coefficient for this method, otherwise the above equation will require a system solve. Finally, the end-of-step velocities are calculated from the end of step acceleration:
Note that the velocities may be stored at the midstep, resulting one less kinematic update. This approach is typically referred to as the “Leapfrog” method. However, in GEOS we do not offer this option since it can cause some confusion that results from the storage of state at different points in time.
Parameters
In the preceding XML block, The SolidMechanics_LagrangianFEM is specified by the title of the subblock of the Solvers block. The following attributes are supported in the input block for SolidMechanics_LagrangianFEM:
XML Element: SolidMechanics_LagrangianFEM
Name |
Type |
Default |
Description |
---|---|---|---|
cflFactor |
real64 |
0.5 |
Factor to apply to the CFL condition when calculating the maximum allowable time step. Values should be in the interval (0,1] |
contactPenaltyStiffness |
real64 |
0 |
Value of the penetration penalty stiffness. Units of Pressure/length |
contactRelationName |
groupNameRef |
NOCONTACT |
Name of contact relation to enforce constraints on fracture boundary. |
discretization |
groupNameRef |
required |
Name of discretization object (defined in the Numerical Methods) to use for this solver. For instance, if this is a Finite Element Solver, the name of a Finite Element Discretization should be specified. If this is a Finite Volume Method, the name of a Finite Volume Discretization discretization should be specified. |
initialDt |
real64 |
1e+99 |
Initial time-step value required by the solver to the event manager. |
logLevel |
integer |
0 |
Sets the level of information to write in the standard output (the console typically).
Level 0 outputs no specific information for this solver. Higher levels require more outputs.
1
- Line search information
- Solution information (scaling, maximum changes, quality check)
- Convergence information
- Time step information
- Linear solver information
- Nonlinear solver information
- Solver timers information
2
- The summary of declared fields and coupling
|
massDamping |
real64 |
0 |
Value of mass based damping coefficient. |
maxNumResolves |
integer |
10 |
Value to indicate how many resolves may be executed after some other event is executed. For example, if a SurfaceGenerator is specified, it will be executed after the mechanics solve. However if a new surface is generated, then the mechanics solve must be executed again due to the change in topology. |
name |
groupName |
required |
A name is required for any non-unique nodes |
newmarkBeta |
real64 |
0.25 |
Value of in the Newmark Method for Implicit Dynamic time integration option. This should be pow(newmarkGamma+0.5,2.0)/4.0 unless you know what you are doing. |
newmarkGamma |
real64 |
0.5 |
Value of in the Newmark Method for Implicit Dynamic time integration option |
stiffnessDamping |
real64 |
0 |
Value of stiffness based damping coefficient. |
strainTheory |
integer |
0 |
Indicates whether or not to use Infinitesimal Strain Theory, or Finite Strain Theory. Valid Inputs are:
0 - Infinitesimal Strain
1 - Finite Strain
|
surfaceGeneratorName |
string |
Name of the surface generator to use |
|
targetRegions |
groupNameRef_array |
required |
Allowable regions that the solver may be applied to. Note that this does not indicate that the solver will be applied to these regions, only that allocation will occur such that the solver may be applied to these regions. The decision about what regions this solver will beapplied to rests in the EventManager. |
timeIntegrationOption |
geos_SolidMechanicsLagrangianFEM_TimeIntegrationOption |
ExplicitDynamic |
Time integration method. Options are:
* QuasiStatic
* ImplicitDynamic
* ExplicitDynamic
|
writeLinearSystem |
integer |
0 |
Write matrix, rhs, solution to screen ( = 1) or file ( = 2). |
LinearSolverParameters |
node |
unique |
|
NonlinearSolverParameters |
node |
unique |
The following data are allocated and used by the solver:
Datastructure: SolidMechanics_LagrangianFEM
Name |
Type |
Description |
---|---|---|
maxForce |
real64 |
The maximum force contribution in the problem domain. |
maxStableDt |
real64 |
Value of the Maximum Stable Timestep for this solver. |
meshTargets |
geos_mapBase<std___1_pair<std___1_basic_string<char, std___1_char_traits<char>, std___1_allocator<char>>, std___1_basic_string<char, std___1_char_traits<char>, std___1_allocator<char>>>, LvArray_Array<std___1_basic_string<char, std___1_char_traits<char>, std___1_allocator<char>>, 1, camp_int_seq<long, 0l>, int, LvArray_ChaiBuffer>, std___1_integral_constant<bool, true>> |
MeshBody/Region combinations that the solver will be applied to. |
LinearSolverParameters |
node |
|
NonlinearSolverParameters |
node |
|
SolverStatistics |
node |
Example
An example of a valid XML block is given here:
<Solvers>
<SolidMechanics_LagrangianFEM
name="lagsolve"
strainTheory="1"
cflFactor="0.25"
discretization="FE1"
targetRegions="{ Region2 }"
/>
</Solvers>