FEM Structures Flashcards
(84 cards)
Explain at least three different sources of nonlinearity for finite element problems.
Nonlinearities arise from material nonlinearity (e.g., plasticity, hyperelasticity), geometric nonlinearity (e.g., large deformations or rotations), and boundary condition nonlinearity (e.g., contact problems where contact points are not predefined).
Define the small strain tensor in terms of the displacement vector.
The small strain tensor is defined as ε_ij = 1/2(∂u_i/∂x_j + ∂u_j/∂x_i), where u_i is the displacement in the i-direction.
Considering an FE approximation of displacements, show how to compute Voigt matrix strain.
Using u ≈ N a, the strain is ε = B a, where B is the strain-displacement matrix derived from shape function derivatives.
Explain how to define a nonlinear problem in terms of a residual g and how this impacts the solution procedure.
The residual g represents the imbalance in the system: g(u) = f_int - f_ext. Iterative methods like Newton-Raphson minimize g to achieve equilibrium.
Define the Jacobian matrix associated with Newton iterations.
The Jacobian (tangent stiffness matrix) is K = ∂g/∂u, where g is the residual vector.
Explain what is meant by convergence of Newton iterations.
Convergence occurs when the residual norm ||g|| falls below a tolerance ε. It is detected by monitoring ||g|| or the reduction rate over iterations.
Based on the quasistatic balance of linear momentum, derive the internal and external virtual work for small strains.
Internal virtual work: δW_int = ∫_V δε_ij σ_ij dV. External virtual work: δW_ext = ∫_V δu_i f_i dV + ∫_S δu_i t_i dS, where σ_ij is stress, f_i is body force, and t_i are tractions.
Introduce a 2D finite element approximation and derive internal and external force vectors.
Using u ≈ N a and δu ≈ N δa, internal force vector: f_int = ∫_V B^T σ dV, and external force vector: f_ext = ∫_V N^T f dV + ∫_S N^T t dS.
Define the residual vector for a nonlinear material problem under small strains.
The residual vector is g = f_int - f_ext, representing the imbalance between internal and external forces.
Define the Jacobian matrix for Newton iterations and how material tangent behavior enters.
The Jacobian matrix is K = ∫_V B^T C_tangent B dV, where C_tangent is the material tangent stiffness matrix.
Show how the internal force vector and tangent stiffness matrix are computed from element contributions.
Internal force: f_e,int = ∫_Ve B^T σ dV. Tangent stiffness: K_e = ∫_Ve B^T C_tangent B dV. Global matrices are assembled by summing element contributions.
Explain why linear triangular elements may be less suitable for plasticity problems.
Linear triangular elements assume constant strain, which poorly captures stress gradients in plastic zones, leading to inaccuracies.
Compute the Jacobian matrix for a 6-noded isoparametric triangular element.
For a 6-noded element, F_isop = [[∂x/∂ξ ∂x/∂η], [∂y/∂ξ ∂y/∂η]]. Compute derivatives using nodal coordinates.
Show that [∂Na/∂Xi] = [F_isop^-T][∂Na/∂ξj].
Using the chain rule, ∂Na/∂Xi = ∂Na/∂ξj * ∂ξj/∂Xi. The inverse transpose of the Jacobian matrix transforms derivatives from local to global coordinates.
Show how to compute the B_e-matrix for a 6-noded isoparametric triangular element.
The B_e matrix is derived from shape function derivatives transformed using the inverse Jacobian. B_e relates nodal displacements to strains.
Explain how the Jacobian matrix enters FE equations for internal force and stiffness matrix.
The Jacobian maps integrals from global to parent domains: ∫V (…) dV = ∫ξ (…) |det(J)| dξ.
Show how numerical integration can evaluate element contributions f_e,int and K_e.
Use Gaussian quadrature: f_e,int = Σ B^T σ w |det(J)|, K_e = Σ B^T C_tangent B w |det(J)|, summing over Gauss points.
Explain path-dependent material behavior and its impact on FE implementation.
Path-dependent materials require history variables (e.g., plastic strain) stored and updated at integration points during simulations.
Describe von Mises plasticity with isotropic hardening.
Von Mises plasticity involves yielding based on stress invariants: σ_y = σ_0 + H ε_p. Elastic loading occurs when σ_von Mises < σ_y.
Compute von Mises stress for a 3D stress state.
Von Mises stress: σ_von Mises = √(3/2 * s_ij * s_ij), where s_ij = σ_ij - 1/3 σ_kk δ_ij is the deviatoric stress.
Explain the concept of trial stress and show two ways to compute it.
Trial stress: σ_trial = σ^n + C : (ε^n+1 - ε^n), where σ^n is the previous stress state, and C is the elasticity matrix.
Show how to determine elastic or plastic loading based on trial stress.
If f = σ_trial - σ_y ≤ 0, the loading is elastic. If f > 0, plastic loading occurs, requiring stress corrections.
Describe continuum motion φ(X, t) for basic motions.
Continuum motion maps a material point X in the reference configuration to x in the current configuration: x = φ(X, t). Examples include pure elongation, simple shear, and pure rotation.
Define the deformation gradient F and compute it from φ(X, t) or displacement u(X, t).
The deformation gradient is F = ∂φ/∂X = I + ∂u/∂X, where u = x - X. It transforms line elements in the reference configuration to the current configuration.