Finite Element Formulation
Finite Element Approximation
In the finite element method, the motion is approximated by:
- Interpolating shape functions
- Position vector of node
Similarly, nodal displacements are defined using Material and Spatial Coordinates, Equation 2 at nodes:
The displacement field is:
The velocities are obtained by taking the material time derivative of the displacement giving:
It is worth pointing out that the velocity is a material time derivative of displacements, that is, the partial derivative with respect to time with the material coordinate fixed.
Finally, accelerations are similarly given by the material time derivative of velocities:
Emphasis is placed on the fact that shapes functions are functions of the material coordinates whatever the updated or the total Lagrangian formulation is used. All the dependency in the finite element approximation of the motion is taken into account in the values of the nodal variables.
From Kinematic Description, Equation 8, the velocity gradient is given by:
and the rate of deformation (Kinematic Description, Equation 14) by:
Similarly, the test functions are approximated as:
Where, are the virtual nodal velocities.
The test functions are next substituted into the principle of virtual power (Virtual Power Principle, Equation 5) giving:
The virtual velocities must be kinematically admissible, that is, satisfy boundary conditions on , the part of the boundary where kinematical conditions are specified. Using the arbitrariness of the virtual nodal velocities everywhere except on , the weak form of the momentum equation is:
with the part of the boundary where traction loads are imposed.
Internal and External Nodal Forces
As in Virtual Power Term Names, you define the nodal forces corresponding to each term in the virtual power equation.
The internal nodal forces are defined by:
The stress is the true (Cauchy) stress.
These nodal forces are called internal because they represent the stresses in the body. The expression applies to both the complete mesh or to any element. It is pointed out that derivatives are taken with respect to spatial coordinates and that integration is taken over the current deformed configuration.
The external forces are similarly defined in terms of the virtual external power:
so that external forces are given by:
Mass Matrix and Inertial Forces
The inertial body forces are defined by:
so that the inertia forces are given by:
or using the Finite Element Approximation, Equation 5 for the accelerations:
It is usual to define the inertial nodal forces as the product of a mass matrix and the nodal accelerations. Defining the mass matrix as:
the inertial forces are given by:
Discrete Equations
Using the definitions of the internal and external forces, as well as the definition of the inertial forces, it is possible to write the weak form of the virtual power principle as:
or taking into account the arbitrariness of the virtual velocities:
Equation of Motion for Translational Velocities
Discrete Equations, Equation 21 is written in matrix notation as:
This is Newton's equation, where the mass matrix is:
Radioss uses a lumped mass approach, that is, each node represents a discrete mass of zero size. This creates a diagonal mass matrix , eliminating, as you will see in Dynamic Analysis, the need to solve simultaneous equations for the solution of nodal accelerations.
is the externally applied load vector, and the internal force vector is:
Adding to the internal and external forces the anti-hourglass force vector and the contact force vector which will be described in the following sections, you obtain the overall equation of motion:
Equation of Motion for Angular Velocities
Shell, beam and rigid body theory introduces nodal rotational degrees of freedom. The equations of motion for rotational degrees of freedom are complicated if written in the global reference frame. They are much simpler if written for each node in the principal reference frame attached to the node. The resulting equations are the standard Euler equations. They are completely analogous to Newton's law governing translational degrees of freedom and are stated as:
- Principal moments of inertia about the x, y and z axes respectively
- Angular accelerations expressed in the principal reference frame
- Angular velocities
- Principal externally applied moments
- Principal internal moments
The equation of motion for rotational degrees of freedom is thus very similar to that for translational degrees of freedom. In matrix notation and in the nodal principal reference frame:
The vector function is computed for a value of at . Equation 30 is used for rigid body motion.
For shell, beam and spring using a spherical inertia, the equation of motion becomes:
- Diagonal inertia matrix
- Externally applied moment vector
- Internal moment vector
- Anti-hourglass shell moment vector
Element Coordinates
Finite elements are usually developed with shape functions expressed in terms of an intrinsic coordinates system . It is shown hereafter that expressing the shape functions in terms of intrinsic coordinates is equivalent to using material coordinates.
- The domain in the intrinsic coordinates system
- The current element domain
- The initial reference element domain
is associated with the direction .
is associated with the direction .
is associated with the direction .
- The map from the intrinsic coordinates system to the initial configuration:
- The map from the intrinsic coordinates system to the current configuration:
- The map from the initial to the current configuration:
So, it is possible to approximate the motion in an element by:
Shape functions have no dimensions. They simply relate coordinates in the physical world to the intrinsic coordinates system. Writing Equation 35 at =0, you obtain:
So, it can be seen from the last equation that the material coordinates system and the intrinsic coordinates system are invariant in a Lagrangian element. As a result, as intrinsic coordinates are time invariant and it is possible to write displacements, velocities and accelerations in terms of intrinsic coordinates (one coordinate system, the two other coordinates have similar shape functions):
Isoparametric elements use the same shape functions for the interpolation of and .
Integration and Nodal Forces
In practice, integrals over the current domain in the definition of the internal nodal forces (Equation of Motion for Translational Velocities, Equation 25), of the external nodal forces (Equation of Motion for Translational Velocities, Equation 24) and of the mass matrix have to be transformed into integrals over the domain in the intrinsic coordinate system .
Using Vicinity Transformation, Equation 5, integrals on the current configuration are related to integrals over the reference configuration and over the domain in the intrinsic coordinate system by:
and
- The Jacobian determinant of the transformation between the current and the initial configuration
- The Jacobian determinant of the transformation between the current configuration and the domain in the intrinsic coordinate system
- The Jacobian determinant of the transformation between the reference configuration and the intrinsic coordinate system
On the other hand, it comes from Vicinity Transformation, Equation 2 and Element Coordinates, Equation 35:
So, using Equation 40, internal forces computed by integration over the current domain will be obtained by the following quadrature:
and obtained from Equation 42.
External forces and the mass matrix can similarly be integrated over the domain in the intrinsic coordinate system.
Function Derivatives
The definition of internal forces also shows that derivatives of the form:
need to be computed. These spatial derivatives are obtained by implicit differentiation. Considering the velocity gradient such as:
one has:
Where, the Jacobian matrix of the map between the current coordinates and the intrinsic coordinates is:
Usually, it is not possible to have closed form expression of the Jacobian matrix. As a result the inversion will be performed numerically and numerical quadrature will be necessary for the evaluation of nodal forces.
Numerical Quadrature: Reduced Integration
All elements in Radioss are integrated numerically. Hence, the integrals for nodal forces are replaced by a summation:
- Number of integration points in the element
- Eeight associated to the integration point
For full integration, the number of integration points is sufficient for the exact integration of the virtual work expression. The full integration scheme is often used in programs for static or dynamic problems with implicit time integration. It presents no problem for stability, but sometimes involves locking and the computation is often expensive.
Reduced integration can also be used. In this case, the number of integration points is sufficient for the exact integration of the contributions of the strain field that are one order less than the order of the shape functions. The incomplete higher order contributions to the strain field present in these elements are not integrated.
The reduced integration scheme, especially with one-point quadrature is widely used in programs with explicit time integration to compute the force vectors. It drastically decreases the computation time, and is very competitive if the spurious singular modes (often called hourglass modes which result from the reduced integration scheme) are properly stabilized. In two dimensions, a one point integration scheme will be almost four times less expensive than a four point integration scheme. The savings are even greater in three dimensions. The use of one integration point is recommended to save CPU time, but also to avoid "locking" problems, for example, shear locking or volume locking.
Shear locking is related to bending behavior. In the stress analysis of relatively thin members subjected to bending, the strain variation through the thickness must be at least linear, so constant strain first order elements are not well suited to represent this variation, leading to shear locking. Fully integrated first-order isoparametric elements (tetrahedron) also suffer from shear locking in the geometries where they cannot provide the pure bending solution because they must shear at the numerical integration points to represent the bending kinematic behavior. This shearing then locks the element, that is, the response is far too stiff.
On the other hand, most fully integrated solid elements are unsuitable for the analysis of approximately incompressible material behavior (volume locking). The reason for this is that the material behavior forces the material to deform approximately without volume changes. Fully-integrated solid elements, and in particular low-order elements do not allow such deformations. This is another reason for using selectively reduced integration. Reduced integration is used for volume strain and full integration is used for the deviatoric strains.
However, as mentioned above, the disadvantage of reduced integration is that the element can admit deformation modes that are not causing stresses at the integration points. These zero-energy modes make the element rank-deficient which causes a phenomenon called hour-glassing; the zero-energy modes start propagating through the mesh, leading to inaccurate solutions. This problem is particularly severe in first-order quadrilaterals and hexahedra.
To prevent these excessive deformations, a small artificial stiffness or viscosity associated with the zero-energy deformation modes is added, leading in Equation of Motion for Translational Velocities, Equation 22 and Equation of Motion for Angular Velocities, Equation 30 to anti-hourglass force and moment vectors:
Zero-energy or hourglass modes are controlled using a perturbation stabilization as described by Flanagan-Belytschko 1, or physical stabilization as described in 2 (Element Library).
So, for isoparametric elements, reduced integration allows simple and cost effective computation of the volume integrals, in particular on vectorized supercomputers, and furnishes a simple way to cope with locking aspects, but at the cost of allowing hour-glassing.
Numerical Procedures
- For the displacement, velocity and acceleration at a particular time step, the external force vector is constructed and applied.
- A loop over element is performed, in which the internal and hourglass forces are
computed, along with the size of the next time step. The procedure for this loop is:
- The Jacobian matrix is used to relate displacements in the intrinsic coordinates
system to the physical space:
- The strain rate is calculated:
- The stress rate is calculated:
- Cauchy stresses are computed using explicit time integration:
- The internal and hourglass force vectors are computed.
- The next time step size is computed, using element or nodal time step methods (Dynamic Analysis)
- The Jacobian matrix is used to relate displacements in the intrinsic coordinates
system to the physical space:
- After the internal and hourglass forces are calculated for each element, the algorithm proceeds by computing the contact forces between any interfaces.
- With all forces known, the new accelerations are calculated using the mass matrix and
the external and internal force vectors:
- Finally, time integration of velocity and displacement is performed using the new
value.
Figure 1. Numerical Procedure
A Uniform Strain Hexahedron and Quadrilateral with Orthogonal Hourglass Control, Int. Journal Num. Methods in Engineering, 17 679-706, 1981.
A New One-point Quadrature, General Nonlinear Quadrilateral Shell Element with Physical Stabilization, Int. Journal Num. Methods in Engineering 42, 1307-1338, 1998.