OpenCMISS-Iron Internal API Documentation
finite_elasticity_routines Module Reference

This module handles all finite elasticity routines. More...

Functions/Subroutines

subroutine, public finiteelasticity_boundaryconditionsanalyticcalculate (EQUATIONS_SET, BOUNDARY_CONDITIONS, ERR, ERROR,)
 Calculates the analytic solution and sets the boundary conditions for an analytic problem. More...
 
subroutine finiteelasticity_cylinderanalyticcalculate (X, ANALYTIC_USER_PARAMS, DEFORMED_X, P, ERR, ERROR,)
 Calcualates the analytic solution (deformed coordinates and hydrostatic pressure) for cylinder inflation+extension+torsion problem. More...
 
real(dp) function finite_elasticity_cylinder_analytic_func_evaluate (MU1, PIN, POUT, LAMBDA, TSI, A1, A2, C1, C2)
 Evaluates the residual function required to solve for MU1, in the cylinder analytic example. More...
 
subroutine finite_elasticity_gauss_elasticity_tensor (EQUATIONS_SET, DEPENDENT_INTERPOLATED_POINT, MATERIALS_INTERPOLATED_POINT, ELASTICITY_TENSOR, HYDRO_ELASTICITY_VOIGT, STRESS_TENSOR, DZDNU, Jznu, ELEMENT_NUMBER, GAUSS_POINT_NUMBER, ERR, ERROR,)
 Evaluates the spatial elasticity and stress tensor in Voigt form at a given Gauss point. More...
 
subroutine, public finiteelasticity_finiteelementjacobianevaluate (EQUATIONS_SET, ELEMENT_NUMBER, ERR, ERROR,)
 Evaluates the element Jacobian matrix for the given element number for a finite elasticity class finite element equation set. More...
 
subroutine finite_elasticity_push_elasticity_tensor (ELASTICITY_TENSOR, DZDNU, Jznu, ERR, ERROR,)
 Push-forward the rank 4 elasticity tensor. More...
 
subroutine finite_elasticity_push_stress_tensor (STRESS_TENSOR, DZDNU, Jznu, ERR, ERROR,)
 Push-forward the rank 2 Piola stress tensor. More...
 
subroutine finiteelasticity_gaussgrowthtensor (equationsSet, numberOfDimensions, gaussPointNumber, elementNumber, dependentField, deformationGradientTensor, growthTensor, elasticDeformationGradientTensor, Jg, Je, err, error,)
 Evaluates the growth tensor at a given Gauss point and calculates the elastic part of the deformation gradient tensor. More...
 
subroutine finiteelasticity_straintensor (deformationGradientTensor, rightCauchyDeformationTensor, fingerDeformationTensor, Jacobian, greenStrainTensor, err, error,)
 Evaluates the strain tensor given the deformation gradient tensor. More...
 
subroutine, public finiteelasticity_finiteelementresidualevaluate (EQUATIONS_SET, ELEMENT_NUMBER, ERR, ERROR,)
 Evaluates the residual and RHS vectors for a finite elasticity finite element equations set. More...
 
subroutine, public finiteelasticity_finiteelementpreresidualevaluate (EQUATIONS_SET, ERR, ERROR,)
 Pre-evaluates the residual for a finite elasticity finite element equations set. More...
 
subroutine, public finiteelasticity_finiteelementpostresidualevaluate (EQUATIONS_SET, ERR, ERROR,)
 Post-evaluates the residual for a finite elasticity finite element equations set. More...
 
subroutine, public finiteelasticityequationsset_derivedvariablecalculate (equationsSet, derivedType, err, error,)
 Calculated an output field for a finite elasticity equations set. More...
 
subroutine, public finiteelasticity_straincalculate (equationsSet, strainField, strainFieldVariableType, err, error,)
 Calculates the strain field for a finite elasticity finite element equations set. More...
 
subroutine, public finiteelasticity_tensorinterpolatexi (equationsSet, tensorEvaluateType, userElementNumber, xi, values, err, error,)
 Evaluates a tensor at a given element xi location. More...
 
subroutine finiteelasticity_surfacepressurejacobianevaluate (EQUATIONS_SET, ELEMENT_NUMBER, ERR, ERROR,)
 
subroutine finiteelasticity_surfacepressureresidualevaluate (EQUATIONS_SET, ELEMENT_NUMBER, var1, var2, ERR, ERROR,)
 
subroutine, public finiteelasticity_gaussdeformationgradienttensor (dependentInterpPointMetrics, geometricInterpPointMetrics, fibreInterpolatedPoint, dZdNu, err, error,)
 Evaluates the deformation gradient tensor at a given Gauss point. More...
 
subroutine finite_elasticity_gauss_cauchy_tensor (EQUATIONS_SET, DEPENDENT_INTERPOLATED_POINT, MATERIALS_INTERPOLATED_POINT, DARCY_DEPENDENT_INTERPOLATED_POINT, INDEPENDENT_INTERPOLATED_POINT, CAUCHY_TENSOR, Jznu, DZDNU, ELEMENT_NUMBER, GAUSS_POINT_NUMBER, ERR, ERROR,)
 Evaluates the Cauchy stress tensor at a given Gauss point. More...
 
subroutine finiteelasticity_gaussgrowthtensor_newer123 (equationsSet, numberOfDimensions, gaussPointNumber, elementNumber, dependentField, deformationGradientTensor, growthTensor, elasticDeformationGradientTensor, Jg, Je, err, error,)
 Evaluates the growth tensor at a given Gauss point and calculates the elastic part of the deformation gradient tensor. More...
 
subroutine finiteelasticity_straintensor_newer123 (deformationGradientTensor, rightCauchyDeformationTensor, fingerDeformationTensor, Jacobian, greenStrainTensor, err, error,)
 Evaluates the strain tensor given the deformation gradient tensor. More...
 
subroutine finite_elasticity_gauss_stress_tensor (EQUATIONS_SET, DEPENDENT_INTERPOLATED_POINT, MATERIALS_INTERPOLATED_POINT, STRESS_TENSOR, DZDNU, Jznu, ELEMENT_NUMBER, GAUSS_POINT_NUMBER, ERR, ERROR,)
 Evaluates the Cauchy stress tensor at a given Gauss point. More...
 
subroutine finiteelasticity_piolaaddactivecontraction (INDEPENDENT_FIELD, MATERIALS_FIELD, PIOLA_FF, E_FF, ELEMENT_NUMBER, GAUSS_POINT_NUMBER, ERR, ERROR,)
 
subroutine finite_elasticity_fmm (TIME, DT, PREV_LAMBDA, CURR_LAMBDA, Q123, ISO_TA, TA)
 
subroutine finite_elasticity_gauss_dfdz (INTERPOLATED_POINT, ELEMENT_NUMBER, GAUSS_POINT_NUMBER, NUMBER_OF_DIMENSIONS, NUMBER_OF_XI, DFDZ, ERR, ERROR,)
 Evaluates df/dz (derivative of interpolation function wrt deformed coord) matrix at a given Gauss point. More...
 
subroutine, public finite_elasticity_equations_set_setup (EQUATIONS_SET, EQUATIONS_SET_SETUP, ERR, ERROR,)
 Sets up the finite elasticity equation type of an elasticity equations set class. More...
 
subroutine, public finiteelasticity_equationssetsolutionmethodset (EQUATIONS_SET, SOLUTION_METHOD, ERR, ERROR,)
 Sets/changes the solution method for a finite elasticity equation type of an elasticity equations set class. More...
 
subroutine, public finiteelasticity_equationssetspecificationset (equationsSet, specification, err, error,)
 Sets the equation specification for a finite elasticity equation type of an elasticity equations set class. More...
 
subroutine, public finite_elasticity_problem_setup (PROBLEM, PROBLEM_SETUP, ERR, ERROR,)
 Sets up the finite elasticity problem. More...
 
subroutine, public finiteelasticity_contactproblemsetup (PROBLEM, PROBLEM_SETUP, ERR, ERROR,)
 Sets up the finite elasticity problem. More...
 
subroutine, public finiteelasticity_problemspecificationset (problem, problemSpecification, err, error,)
 Sets the problem specification for a finite elasticity type problem. More...
 
subroutine, public finiteelasticity_contactproblemspecificationset (problem, problemSpecification, err, error,)
 Sets/changes the problem subtype for a finite elasticity contact type . More...
 
subroutine, public finite_elasticity_post_solve (CONTROL_LOOP, SOLVER, ERR, ERROR,)
 Sets up the finite elasticity problem post solve. More...
 
subroutine, public finite_elasticity_post_solve_output_data (CONTROL_LOOP, SOLVER, ERR, ERROR,)
 Sets up the finite elasticity problem post solve output data. More...
 
subroutine, public finiteelasticity_controltimelooppreloop (CONTROL_LOOP, ERR, ERROR,)
 Runs before each time loop for a finite elasticity problem. More...
 
subroutine, public finiteelasticity_controlloadincrementlooppostloop (controlLoop, err, error,)
 Executes after each loop of a control loop for finite elasticity problems, i.e., after each load increment in a load increment loop. More...
 
subroutine, public finite_elasticity_pre_solve (CONTROL_LOOP, SOLVER, ERR, ERROR,)
 Sets up the finite elasticity problem pre-solve. More...
 
subroutine finite_elasticity_evaluate_evolution_law (SOLVER, ERR, ERROR,)
 Evaluates the evolution law of a multiscale active strain muscle model. More...
 
subroutine finiteelasticity_presolvegetsoliddisplacement (CONTROL_LOOP, SOLVER, ERR, ERROR,)
 Read in the displacement field for a PGM elasticity problem. More...
 
subroutine finiteelasticity_presolveupdateboundaryconditions (CONTROL_LOOP, SOLVER, ERR, ERROR,)
 Update boundary conditions for finite elasticity pre solve. More...
 
subroutine, public evaluate_chapelle_function (Jznu, ffact, dfdJfact, ERR, ERROR,)
 Evaluates the functions f(J) and f\'(J); Eq.(21) in Chapelle, Gerbeau, Sainte-Marie, Vignon-Clementel, Computational Mechanics (2010) More...
 
subroutine evaluate_chapelle_piola_tensor_addition (AZL, AZU, DARCY_MASS_INCREASE, PIOLA_TENSOR_ADDITION, ERR, ERROR,)
 Evaluates the 2nd Piola-Kirchhoff stress tensor; Eq.(13) in Chapelle, Gerbeau, Sainte-Marie, Vignon-Clementel, Computational Mechanics (2010) More...
 
subroutine, public get_darcy_finite_elasticity_parameters (DARCY_RHO_0_F, Mfact, bfact, p0fact, ERR, ERROR,)
 Sets some data for the coupled Darcy / finite-elasticity model. More...
 
subroutine, public finite_elasticity_load_increment_apply (EQUATIONS_SET, ITERATION_NUMBER, MAXIMUM_NUMBER_OF_ITERATIONS, ERR, ERROR,)
 Apply load increments to the gravity vector. More...
 

Variables

integer(intg), parameter, public finite_elasticity_analytic_cylinder_param_pin_idx =1
 Inner pressure parameter index. More...
 
integer(intg), parameter, public finite_elasticity_analytic_cylinder_param_pout_idx =2
 Outer pressure parameter index. More...
 
integer(intg), parameter, public finite_elasticity_analytic_cylinder_param_lambda_idx =3
 Lambda parameter index. More...
 
integer(intg), parameter, public finite_elasticity_analytic_cylinder_param_tsi_idx =4
 Tsi parameter index. More...
 
integer(intg), parameter, public finite_elasticity_analytic_cylinder_param_rin_idx =5
 Inner radius parameter index. More...
 
integer(intg), parameter, public finite_elasticity_analytic_cylinder_param_rout_idx =6
 Outer radius parameter index. More...
 
integer(intg), parameter, public finite_elasticity_analytic_cylinder_param_c1_idx =7
 c1 parameter index More...
 
integer(intg), parameter, public finite_elasticity_analytic_cylinder_param_c2_idx =8
 c2 parameter index More...
 

Detailed Description

This module handles all finite elasticity routines.

Function/Subroutine Documentation

subroutine, public finite_elasticity_routines::evaluate_chapelle_function ( real(dp), intent(in)  Jznu,
real(dp), intent(out)  ffact,
real(dp), intent(out)  dfdJfact,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Evaluates the functions f(J) and f\'(J); Eq.(21) in Chapelle, Gerbeau, Sainte-Marie, Vignon-Clementel, Computational Mechanics (2010)

Parameters
[in]jznuJznu=DETERMINANT(AZL,ERR,ERROR)**0.5_DP
[out]ffactf(Jznu) of the INRIA model
[out]dfdjfactdfdJfact = f'(Jznu) of the INRIA model
[out]errThe error code
[out]errorThe error string

Definition at line 10814 of file finite_elasticity_routines.f90.

References base_routines::enters(), and base_routines::exits().

Referenced by darcy_equations_routines::darcy_equation_finite_element_calculate(), evaluate_chapelle_piola_tensor_addition(), and finite_elasticity_gauss_cauchy_tensor().

subroutine finite_elasticity_routines::evaluate_chapelle_piola_tensor_addition ( real(dp), dimension(3,3), intent(in)  AZL,
real(dp), dimension(3,3), intent(in)  AZU,
real(dp), intent(in)  DARCY_MASS_INCREASE,
real(dp), dimension(3,3), intent(out)  PIOLA_TENSOR_ADDITION,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private

Evaluates the 2nd Piola-Kirchhoff stress tensor; Eq.(13) in Chapelle, Gerbeau, Sainte-Marie, Vignon-Clementel, Computational Mechanics (2010)

Parameters
[in]azlC=F\'F
[in]azuinverse of AZL
[in]darcy_mass_increasemass increase
[out]piola_tensor_additionAddition to the 2nd Piola-Kirchhoff tensor
[out]errThe error code
[out]errorThe error string

Definition at line 10848 of file finite_elasticity_routines.f90.

References base_routines::diagnostic_output_type, base_routines::diagnostics1, base_routines::enters(), evaluate_chapelle_function(), base_routines::exits(), get_darcy_finite_elasticity_parameters(), and input_output::write_string_matrix_name_and_indices.

real(dp) function finite_elasticity_routines::finite_elasticity_cylinder_analytic_func_evaluate ( real(dp)  MU1,
real(dp)  PIN,
real(dp)  POUT,
real(dp)  LAMBDA,
real(dp)  TSI,
real(dp)  A1,
real(dp)  A2,
real(dp)  C1,
real(dp)  C2 
)
private

Evaluates the residual function required to solve for MU1, in the cylinder analytic example.

Definition at line 593 of file finite_elasticity_routines.f90.

References fluid_mechanics_io_routines::element_number.

Referenced by finiteelasticity_cylinderanalyticcalculate().

subroutine, public finite_elasticity_routines::finite_elasticity_equations_set_setup ( type(equations_set_type), pointer  EQUATIONS_SET,
type(equations_set_setup_type), intent(inout)  EQUATIONS_SET_SETUP,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Sets up the finite elasticity equation type of an elasticity equations set class.

Parameters
equations_setA pointer to the equations set to setup a Laplace equation on.
[in,out]equations_set_setupThe equations set setup information
[out]errThe error code
[out]errorThe error string

Definition at line 5761 of file finite_elasticity_routines.f90.

References base_routines::enters(), equations_routines::equations_create_finish(), equations_routines::equations_create_start(), equations_matrices_routines::equations_jacobian_finite_difference_calculated, equations_routines::equations_linearity_type_set(), equations_mapping_routines::equations_mapping_create_finish(), equations_mapping_routines::equations_mapping_create_start(), equations_mapping_routines::equations_mapping_rhs_variable_type_set(), equations_matrices_routines::equations_matrices_create_finish(), equations_matrices_routines::equations_matrices_create_start(), equations_matrices_routines::equations_matrices_full_matrices, equations_matrices_routines::equations_matrices_sparse_matrices, equations_matrices_routines::equations_matrix_fem_structure, equations_set_constants::equations_nonlinear, equations_set_constants::equations_quasistatic, equations_set_constants::equations_set_1d3d_monodomain_active_strain_subtype, equations_set_constants::equations_set_1d3d_monodomain_elasticity_subtype, equations_set_constants::equations_set_active_strain_subtype, equations_set_constants::equations_set_activecontraction_subtype, equations_set_constants::equations_set_anisotropic_polynomial_active_subtype, equations_set_constants::equations_set_anisotropic_polynomial_subtype, equations_set_constants::equations_set_bem_solution_method, equations_set_constants::equations_set_compressible_activecontraction_subtype, equations_set_constants::equations_set_compressible_finite_elasticity_subtype, equations_set_constants::equations_set_constitutive_and_growth_law_in_cellml_subtype, equations_set_constants::equations_set_constitutive_law_in_cellml_evaluate_subtype, equations_set_constants::equations_set_derived_strain, equations_set_constants::equations_set_derived_stress, equations_set_constants::equations_set_elasticity_darcy_inria_model_subtype, equations_set_constants::equations_set_elasticity_fluid_pres_holmes_mow_active_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_holmes_mow_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_static_inria_subtype, equations_set_constants::equations_set_elasticity_multi_compartment_darcy_inria_subtype, equations_routines::equations_set_equations_get(), equations_set_constants::equations_set_fd_solution_method, equations_set_constants::equations_set_fem_solution_method, equations_set_constants::equations_set_finite_elasticity_cylinder, equations_set_constants::equations_set_fv_solution_method, equations_set_constants::equations_set_gfem_solution_method, equations_set_constants::equations_set_gfv_solution_method, equations_set_constants::equations_set_guccione_activecontraction_subtype, equations_set_constants::equations_set_holzapfel_ogden_activecontraction_subtype, equations_set_constants::equations_set_incompressible_elast_multi_comp_darcy_subtype, equations_set_constants::equations_set_incompressible_elasticity_driven_darcy_subtype, equations_set_constants::equations_set_incompressible_elasticity_driven_mr_subtype, equations_set_constants::equations_set_incompressible_finite_elasticity_darcy_subtype, equations_set_constants::equations_set_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_isotropic_exponential_subtype, equations_set_constants::equations_set_membrane_subtype, equations_set_constants::equations_set_monodomain_elasticity_velocity_subtype, equations_set_constants::equations_set_monodomain_elasticity_w_titin_subtype, equations_set_constants::equations_set_mooney_rivlin_activecontraction_subtype, equations_set_constants::equations_set_mooney_rivlin_subtype, equations_set_constants::equations_set_multi_compartment_darcy_subtype, equations_set_constants::equations_set_multiscale_active_strain_subtype, equations_set_constants::equations_set_nearly_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_no_subtype, equations_set_constants::equations_set_number_of_derived_types, equations_set_constants::equations_set_orthotropic_material_costa_subtype, equations_set_constants::equations_set_orthotropic_material_holzapfel_ogden_subtype, equations_set_constants::equations_set_setup_analytic_type, equations_set_constants::equations_set_setup_dependent_type, equations_set_constants::equations_set_setup_derived_type, equations_set_constants::equations_set_setup_equations_type, equations_set_constants::equations_set_setup_finish_action, equations_set_constants::equations_set_setup_geometry_type, equations_set_constants::equations_set_setup_independent_type, equations_set_constants::equations_set_setup_initial_type, equations_set_constants::equations_set_setup_materials_type, equations_set_constants::equations_set_setup_source_type, equations_set_constants::equations_set_setup_start_action, equations_set_constants::equations_set_standard_elasticity_darcy_subtype, equations_set_constants::equations_set_standard_monodomain_elasticity_subtype, equations_set_constants::equations_set_stvenant_kirchoff_activecontraction_subtype, equations_set_constants::equations_set_trans_isotropic_active_transition_subtype, equations_set_constants::equations_set_transverse_isotropic_active_subtype, equations_set_constants::equations_set_transverse_isotropic_exponential_subtype, equations_set_constants::equations_set_transverse_isotropic_guccione_subtype, equations_set_constants::equations_set_transverse_isotropic_humphrey_yin_subtype, equations_set_constants::equations_set_transverse_isotropic_polynomial_subtype, equations_set_constants::equations_static, equations_routines::equations_time_dependence_type_set(), equations_mapping_routines::equationsmapping_linearmatricesnumberset(), equations_mapping_routines::equationsmapping_residualvariablesnumberset(), equations_mapping_routines::equationsmapping_residualvariabletypesset(), equations_matrices_routines::equationsmatrices_jacobiantypesset(), base_routines::exits(), fluid_mechanics_io_routines::field, finiteelasticity_equationssetsolutionmethodset(), matrix_vector::matrix_block_storage_type, matrix_vector::matrix_compressed_row_storage_type, and fluid_mechanics_io_routines::source_field.

Referenced by elasticity_routines::elasticity_equations_set_setup().

subroutine finite_elasticity_routines::finite_elasticity_evaluate_evolution_law ( type(solver_type), pointer  SOLVER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private

Evaluates the evolution law of a multiscale active strain muscle model.

Parameters
solverA pointer to the solver
[out]errThe error code
[out]errorThe error string

Definition at line 9857 of file finite_elasticity_routines.f90.

References basis_routines::basis_default_quadrature_scheme, base_routines::enters(), equations_set_constants::equations_set_1d3d_monodomain_active_strain_subtype, base_routines::errors(), base_routines::exits(), finiteelasticity_gaussdeformationgradienttensor(), constants::first_part_deriv, constants::no_part_deriv, and kinds::ptr.

Referenced by finite_elasticity_pre_solve().

subroutine finite_elasticity_routines::finite_elasticity_fmm ( real(dp), intent(in)  TIME,
real(dp), intent(in)  DT,
real(dp), intent(in)  PREV_LAMBDA,
real(dp), intent(inout)  CURR_LAMBDA,
real(dp), dimension(:), intent(inout)  Q123,
real(dp), intent(in)  ISO_TA,
real(dp), intent(out)  TA 
)
private
subroutine finite_elasticity_routines::finite_elasticity_gauss_cauchy_tensor ( type(equations_set_type), intent(in), pointer  EQUATIONS_SET,
type(field_interpolated_point_type), pointer  DEPENDENT_INTERPOLATED_POINT,
type(field_interpolated_point_type), pointer  MATERIALS_INTERPOLATED_POINT,
type(field_interpolated_point_type), pointer  DARCY_DEPENDENT_INTERPOLATED_POINT,
type(field_interpolated_point_type), pointer  INDEPENDENT_INTERPOLATED_POINT,
real(dp), dimension(:,:), intent(out)  CAUCHY_TENSOR,
real(dp), intent(out)  Jznu,
real(dp), dimension(3,3), intent(in)  DZDNU,
integer(intg), intent(in)  ELEMENT_NUMBER,
integer(intg), intent(in)  GAUSS_POINT_NUMBER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private

Evaluates the Cauchy stress tensor at a given Gauss point.

Parameters
[in]equations_setA pointer to the equations set
[in]gauss_point_numberElement/Gauss point number
[out]errThe error code
[out]errorThe error string

Definition at line 3659 of file finite_elasticity_routines.f90.

References base_routines::diagnostic_output_type, base_routines::diagnostics1, base_routines::enters(), equations_set_constants::equations_set_1d3d_monodomain_active_strain_subtype, equations_set_constants::equations_set_1d3d_monodomain_elasticity_subtype, equations_set_constants::equations_set_active_strain_subtype, equations_set_constants::equations_set_activecontraction_subtype, equations_set_constants::equations_set_anisotropic_polynomial_active_subtype, equations_set_constants::equations_set_anisotropic_polynomial_subtype, equations_set_constants::equations_set_compressible_activecontraction_subtype, equations_set_constants::equations_set_compressible_finite_elasticity_subtype, equations_set_constants::equations_set_elasticity_darcy_inria_model_subtype, equations_set_constants::equations_set_elasticity_fluid_pres_holmes_mow_active_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_holmes_mow_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_static_inria_subtype, equations_set_constants::equations_set_guccione_activecontraction_subtype, equations_set_constants::equations_set_holzapfel_ogden_activecontraction_subtype, equations_set_constants::equations_set_incompressible_elast_multi_comp_darcy_subtype, equations_set_constants::equations_set_incompressible_elasticity_driven_darcy_subtype, equations_set_constants::equations_set_incompressible_finite_elasticity_darcy_subtype, equations_set_constants::equations_set_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_isotropic_exponential_subtype, equations_set_constants::equations_set_membrane_subtype, equations_set_constants::equations_set_monodomain_elasticity_velocity_subtype, equations_set_constants::equations_set_monodomain_elasticity_w_titin_subtype, equations_set_constants::equations_set_mooney_rivlin_activecontraction_subtype, equations_set_constants::equations_set_mooney_rivlin_subtype, equations_set_constants::equations_set_multiscale_active_strain_subtype, equations_set_constants::equations_set_nearly_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_no_subtype, equations_set_constants::equations_set_orthotropic_material_costa_subtype, equations_set_constants::equations_set_orthotropic_material_holzapfel_ogden_subtype, equations_set_constants::equations_set_standard_monodomain_elasticity_subtype, equations_set_constants::equations_set_stvenant_kirchoff_activecontraction_subtype, equations_set_constants::equations_set_trans_isotropic_active_transition_subtype, equations_set_constants::equations_set_transverse_isotropic_active_subtype, equations_set_constants::equations_set_transverse_isotropic_exponential_subtype, equations_set_constants::equations_set_transverse_isotropic_guccione_subtype, equations_set_constants::equations_set_transverse_isotropic_humphrey_yin_subtype, equations_set_constants::equations_set_transverse_isotropic_polynomial_subtype, evaluate_chapelle_function(), base_routines::exits(), finiteelasticity_piolaaddactivecontraction(), constants::no_part_deriv, and input_output::write_string_matrix_name_and_indices.

Referenced by finiteelasticity_finiteelementresidualevaluate(), and finiteelasticity_tensorinterpolatexi().

subroutine finite_elasticity_routines::finite_elasticity_gauss_dfdz ( type(field_interpolated_point_type), pointer  INTERPOLATED_POINT,
integer(intg), intent(in)  ELEMENT_NUMBER,
integer(intg), intent(in)  GAUSS_POINT_NUMBER,
integer(intg), intent(in)  NUMBER_OF_DIMENSIONS,
integer(intg), intent(in)  NUMBER_OF_XI,
real(dp), dimension(:,:,:), intent(out)  DFDZ,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private

Evaluates df/dz (derivative of interpolation function wrt deformed coord) matrix at a given Gauss point.

Parameters
interpolated_pointInterpolated point for the dependent field
[in]element_numberThe element number
[in]gauss_point_numberThe gauss point number
[in]number_of_dimensionsThe number of dimensions
[in]number_of_xiThe number of xi directions for the interpolation
[out]dfdzOn return, a matrix containing the derivatives of the basis functions wrt the deformed coordinates
[out]errThe error code
[out]errorThe error string

Definition at line 5684 of file finite_elasticity_routines.f90.

References basis_routines::basis_default_quadrature_scheme, base_routines::enters(), base_routines::exits(), and constants::partial_derivative_first_derivative_map.

Referenced by finiteelasticity_finiteelementresidualevaluate().

subroutine finite_elasticity_routines::finite_elasticity_gauss_elasticity_tensor ( type(equations_set_type), intent(in), pointer  EQUATIONS_SET,
type(field_interpolated_point_type), pointer  DEPENDENT_INTERPOLATED_POINT,
type(field_interpolated_point_type), pointer  MATERIALS_INTERPOLATED_POINT,
real(dp), dimension(:,:), intent(out)  ELASTICITY_TENSOR,
real(dp), dimension(:), intent(out)  HYDRO_ELASTICITY_VOIGT,
real(dp), dimension(:), intent(out)  STRESS_TENSOR,
real(dp), dimension(:,:), intent(in)  DZDNU,
real(dp), intent(in)  Jznu,
integer(intg), intent(in)  ELEMENT_NUMBER,
integer(intg), intent(in)  GAUSS_POINT_NUMBER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private

Evaluates the spatial elasticity and stress tensor in Voigt form at a given Gauss point.

Parameters
[in]equations_setA pointer to the equations set
[out]elasticity_tensorRank 4 elasticity tensor in Voigt notation
[out]hydro_elasticity_voigtRank 2 hydrostatic portion of the elasticity tensor in Voigt notation
[out]stress_tensorRank 2 stress tensor in Voigt notation
[in]dzdnuThe deformation gradient
[in]jznuThe Jacobian
[in]gauss_point_numberElement/Gauss point number
[out]errThe error code
[out]errorThe error string

Definition at line 619 of file finite_elasticity_routines.f90.

References base_routines::enters(), equations_set_constants::equations_set_guccione_activecontraction_subtype, equations_set_constants::equations_set_mooney_rivlin_activecontraction_subtype, equations_set_constants::equations_set_mooney_rivlin_subtype, equations_set_constants::equations_set_transverse_isotropic_guccione_subtype, base_routines::exits(), finite_elasticity_push_elasticity_tensor(), finite_elasticity_push_stress_tensor(), and constants::no_part_deriv.

Referenced by finiteelasticity_finiteelementjacobianevaluate().

subroutine finite_elasticity_routines::finite_elasticity_gauss_stress_tensor ( type(equations_set_type), intent(in), pointer  EQUATIONS_SET,
type(field_interpolated_point_type), pointer  DEPENDENT_INTERPOLATED_POINT,
type(field_interpolated_point_type), pointer  MATERIALS_INTERPOLATED_POINT,
real(dp), dimension(:), intent(out)  STRESS_TENSOR,
real(dp), dimension(3,3), intent(in)  DZDNU,
real(dp), intent(in)  Jznu,
integer(intg), intent(in)  ELEMENT_NUMBER,
integer(intg), intent(in)  GAUSS_POINT_NUMBER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private
subroutine, public finite_elasticity_routines::finite_elasticity_load_increment_apply ( type(equations_set_type), pointer  EQUATIONS_SET,
integer(intg), intent(in)  ITERATION_NUMBER,
integer(intg), intent(in)  MAXIMUM_NUMBER_OF_ITERATIONS,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Apply load increments to the gravity vector.

Parameters
[in]iteration_numberThe current load increment iteration index
[in]maximum_number_of_iterationsFinal index for load increment loop
[out]errThe error code
[out]errorThe error string

Definition at line 10947 of file finite_elasticity_routines.f90.

References base_routines::enters(), and base_routines::exits().

Referenced by elasticity_routines::elasticity_load_increment_apply().

subroutine, public finite_elasticity_routines::finite_elasticity_post_solve_output_data ( type(control_loop_type), pointer  CONTROL_LOOP,
type(solver_type), pointer  SOLVER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
subroutine, public finite_elasticity_routines::finite_elasticity_pre_solve ( type(control_loop_type), pointer  CONTROL_LOOP,
type(solver_type), pointer  SOLVER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Sets up the finite elasticity problem pre-solve.

Parameters
control_loopA pointer to the control loop to solve.
solverA pointer to the solver
[out]errThe error code
[out]errorThe error string

Definition at line 9695 of file finite_elasticity_routines.f90.

References control_loop_routines::control_loop_current_times_get(), base_routines::enters(), equations_set_constants::equations_set_constitutive_and_growth_law_in_cellml_subtype, equations_set_constants::equations_set_constitutive_law_in_cellml_evaluate_subtype, base_routines::exits(), finite_elasticity_evaluate_evolution_law(), finiteelasticity_straincalculate(), base_routines::general_output_type, problem_constants::problem_finite_elasticity_cellml_subtype, problem_constants::problem_finite_elasticity_with_growth_cellml_subtype, problem_constants::problem_gudunov_monodomain_1d3d_elasticity_subtype, problem_constants::problem_gudunov_monodomain_simple_elasticity_subtype, problem_constants::problem_monodomain_1d3d_active_strain_subtype, problem_constants::problem_monodomain_elasticity_velocity_subtype, problem_constants::problem_monodomain_elasticity_w_titin_subtype, problem_constants::problem_multiscale_finite_elasticity_subtype, problem_constants::problem_no_subtype, problem_constants::problem_pgm_elasticity_darcy_subtype, problem_constants::problem_quasistatic_elast_trans_darcy_mat_solve_subtype, problem_constants::problem_quasistatic_elasticity_transient_darcy_subtype, problem_constants::problem_quasistatic_finite_elasticity_subtype, problem_constants::problem_standard_elasticity_darcy_subtype, problem_constants::problem_standard_elasticity_fluid_pressure_subtype, solver_routines::solver_dae_times_set(), solver_routines::solver_progress_output, and solver_routines::solver_solve().

Referenced by bioelectric_finite_elasticity_routines::bioelectric_finite_elasticity_pre_solve(), finite_elasticity_darcy_routines::elasticity_darcy_pre_solve(), finite_elasticity_fluid_pressure_routines::elasticity_fluid_pressure_pre_solve(), and elasticity_routines::elasticity_pre_solve().

subroutine, public finite_elasticity_routines::finite_elasticity_problem_setup ( type(problem_type), pointer  PROBLEM,
type(problem_setup_type), intent(inout)  PROBLEM_SETUP,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Sets up the finite elasticity problem.

Parameters
problemA pointer to the problem set to setup a Laplace equation on.
[in,out]problem_setupThe problem setup information
[out]errThe error code
[out]errorThe error string

Definition at line 8627 of file finite_elasticity_routines.f90.

References solver_routines::cellml_equations_create_finish(), solver_routines::cellml_equations_create_start(), control_loop_routines::control_loop_create_finish(), control_loop_routines::control_loop_create_start(), control_loop_routines::control_loop_node, control_loop_routines::control_loop_solvers_get(), control_loop_routines::control_loop_type_set(), base_routines::enters(), base_routines::exits(), problem_constants::problem_control_load_increment_loop_type, problem_constants::problem_control_time_loop_type, problem_constants::problem_finite_elasticity_cellml_subtype, problem_constants::problem_finite_elasticity_with_growth_cellml_subtype, problem_constants::problem_multiscale_finite_elasticity_subtype, problem_constants::problem_no_subtype, problem_constants::problem_quasistatic_finite_elasticity_subtype, problem_constants::problem_setup_cellml_equations_type, problem_constants::problem_setup_control_type, problem_constants::problem_setup_finish_action, problem_constants::problem_setup_initial_type, problem_constants::problem_setup_solver_equations_type, problem_constants::problem_setup_solvers_type, problem_constants::problem_setup_start_action, solver_routines::solver_cellml_equations_get(), solver_routines::solver_cellml_evaluator_type, solver_routines::solver_cmiss_library, solver_routines::solver_dae_type, solver_routines::solver_equations_create_finish(), solver_routines::solver_equations_create_start(), solver_routines::solver_equations_linearity_type_set(), problem_constants::solver_equations_nonlinear, problem_constants::solver_equations_quasistatic, solver_routines::solver_equations_sparsity_type_set(), problem_constants::solver_equations_static, solver_routines::solver_equations_time_dependence_type_set(), solver_routines::solver_library_type_set(), solver_routines::solver_linked_solver_add(), solver_routines::solver_newton_cellml_evaluator_create(), solver_routines::solver_newton_cellml_solver_get(), solver_routines::solver_nonlinear_type, solver_routines::solver_petsc_library, solver_routines::solver_solver_equations_get(), solver_routines::solver_sparse_matrices, solver_routines::solver_type_set(), solver_routines::solvers_create_finish(), solver_routines::solvers_create_start(), solver_routines::solvers_number_set(), and solver_routines::solvers_solver_get().

Referenced by elasticity_routines::elasticity_problem_setup().

subroutine finite_elasticity_routines::finite_elasticity_push_elasticity_tensor ( real(dp), dimension(6,6), intent(inout)  ELASTICITY_TENSOR,
real(dp), dimension(3,3), intent(in)  DZDNU,
real(dp), intent(in)  Jznu,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private

Push-forward the rank 4 elasticity tensor.

Parameters
[out]errThe error code
[out]errorThe error string

Definition at line 1226 of file finite_elasticity_routines.f90.

References base_routines::enters(), base_routines::exits(), and constants::voigt_to_tensor3.

Referenced by finite_elasticity_gauss_elasticity_tensor().

subroutine finite_elasticity_routines::finite_elasticity_push_stress_tensor ( real(dp), dimension(6), intent(inout)  STRESS_TENSOR,
real(dp), dimension(3,3), intent(in)  DZDNU,
real(dp), intent(in)  Jznu,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private

Push-forward the rank 2 Piola stress tensor.

Parameters
[out]errThe error code
[out]errorThe error string

Definition at line 1265 of file finite_elasticity_routines.f90.

References base_routines::enters(), base_routines::exits(), and constants::voigt_to_tensor3.

Referenced by finite_elasticity_gauss_elasticity_tensor(), and finite_elasticity_gauss_stress_tensor().

subroutine, public finite_elasticity_routines::finiteelasticity_contactproblemsetup ( type(problem_type), pointer  PROBLEM,
type(problem_setup_type), intent(inout)  PROBLEM_SETUP,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Sets up the finite elasticity problem.

Parameters
problemA pointer to the problem set to setup a Laplace equation on.
[in,out]problem_setupThe problem setup information
[out]errThe error code
[out]errorThe error string

Definition at line 8968 of file finite_elasticity_routines.f90.

References control_loop_routines::control_loop_create_finish(), control_loop_routines::control_loop_create_start(), control_loop_routines::control_loop_node, control_loop_routines::control_loop_solvers_get(), control_loop_routines::control_loop_type_set(), base_routines::enters(), base_routines::exits(), problem_constants::problem_control_load_increment_loop_type, problem_constants::problem_fe_contact_reproject_subtype, problem_constants::problem_fe_contact_transform_reproject_subtype, problem_constants::problem_fe_contact_transform_subtype, problem_constants::problem_setup_control_type, problem_constants::problem_setup_finish_action, problem_constants::problem_setup_initial_type, problem_constants::problem_setup_solver_equations_type, problem_constants::problem_setup_solvers_type, problem_constants::problem_setup_start_action, solver_routines::solver_equations_create_finish(), solver_routines::solver_equations_create_start(), solver_routines::solver_equations_linearity_type_set(), problem_constants::solver_equations_nonlinear, solver_routines::solver_equations_sparsity_type_set(), problem_constants::solver_equations_static, solver_routines::solver_equations_time_dependence_type_set(), solver_routines::solver_geometric_transformation_type, solver_routines::solver_library_type_set(), solver_routines::solver_nonlinear_type, solver_routines::solver_petsc_library, solver_routines::solver_solver_equations_get(), solver_routines::solver_sparse_matrices, solver_routines::solver_type_set(), solver_routines::solvers_create_finish(), solver_routines::solvers_create_start(), solver_routines::solvers_number_set(), and solver_routines::solvers_solver_get().

Referenced by elasticity_routines::elasticity_problem_setup().

subroutine, public finite_elasticity_routines::finiteelasticity_contactproblemspecificationset ( type(problem_type), pointer  problem,
integer(intg), dimension(:), intent(in)  problemSpecification,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)

Sets/changes the problem subtype for a finite elasticity contact type .

Parameters
problemA pointer to the problem to set the problem subtype for
[in]problemspecificationThe problem specification to set
[out]errThe error code
[out]errorThe error string

Definition at line 9266 of file finite_elasticity_routines.f90.

References base_routines::enters(), base_routines::errors(), base_routines::exits(), problem_constants::problem_elasticity_class, problem_constants::problem_fe_contact_reproject_subtype, problem_constants::problem_fe_contact_transform_reproject_subtype, problem_constants::problem_fe_contact_transform_subtype, problem_constants::problem_finite_elasticity_contact_type, and problem_constants::problem_no_subtype.

Referenced by elasticity_routines::elasticity_problemspecificationset().

subroutine, public finite_elasticity_routines::finiteelasticity_controlloadincrementlooppostloop ( type(control_loop_type), pointer  controlLoop,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)

Executes after each loop of a control loop for finite elasticity problems, i.e., after each load increment in a load increment loop.

Parameters
controlloopA pointer to the control loop
[out]errThe error code
[out]errorThe error string

Definition at line 9619 of file finite_elasticity_routines.f90.

References base_routines::enters(), base_routines::errors(), base_routines::exits(), field_io_routines::field_io_elements_export(), field_io_routines::field_io_nodes_export(), and problem_constants::problem_control_load_increment_loop_type.

Referenced by elasticity_routines::elasticity_controllooppostloop().

subroutine finite_elasticity_routines::finiteelasticity_cylinderanalyticcalculate ( real(dp), dimension(:), intent(in)  X,
real(dp), dimension(:), intent(in)  ANALYTIC_USER_PARAMS,
real(dp), dimension(3), intent(out)  DEFORMED_X,
real(dp), intent(out)  P,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private

Calcualates the analytic solution (deformed coordinates and hydrostatic pressure) for cylinder inflation+extension+torsion problem.

Parameters
[in]xUndeformed coordinates
[in]analytic_user_paramsArray containing the problem parameters
[out]deformed_xDeformed coordinates
[out]pHydrostatic pressure at the given material coordintae
[out]errThe error code
[out]errorThe error string

Definition at line 499 of file finite_elasticity_routines.f90.

References base_routines::enters(), base_routines::exits(), finite_elasticity_analytic_cylinder_param_c1_idx, finite_elasticity_analytic_cylinder_param_c2_idx, finite_elasticity_analytic_cylinder_param_lambda_idx, finite_elasticity_analytic_cylinder_param_pin_idx, finite_elasticity_analytic_cylinder_param_pout_idx, finite_elasticity_analytic_cylinder_param_rin_idx, finite_elasticity_analytic_cylinder_param_rout_idx, finite_elasticity_analytic_cylinder_param_tsi_idx, finite_elasticity_cylinder_analytic_func_evaluate(), and constants::zero_tolerance.

Referenced by finiteelasticity_boundaryconditionsanalyticcalculate().

subroutine, public finite_elasticity_routines::finiteelasticity_equationssetsolutionmethodset ( type(equations_set_type), pointer  EQUATIONS_SET,
integer(intg), intent(in)  SOLUTION_METHOD,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Sets/changes the solution method for a finite elasticity equation type of an elasticity equations set class.

Parameters
equations_setA pointer to the equations set to set the solution method for
[in]solution_methodThe solution method to set
[out]errThe error code
[out]errorThe error string

Definition at line 8461 of file finite_elasticity_routines.f90.

References base_routines::enters(), equations_set_constants::equations_set_1d3d_monodomain_active_strain_subtype, equations_set_constants::equations_set_1d3d_monodomain_elasticity_subtype, equations_set_constants::equations_set_active_strain_subtype, equations_set_constants::equations_set_activecontraction_subtype, equations_set_constants::equations_set_anisotropic_polynomial_active_subtype, equations_set_constants::equations_set_anisotropic_polynomial_subtype, equations_set_constants::equations_set_bem_solution_method, equations_set_constants::equations_set_compressible_activecontraction_subtype, equations_set_constants::equations_set_compressible_finite_elasticity_subtype, equations_set_constants::equations_set_constitutive_and_growth_law_in_cellml_subtype, equations_set_constants::equations_set_constitutive_law_in_cellml_evaluate_subtype, equations_set_constants::equations_set_elasticity_darcy_inria_model_subtype, equations_set_constants::equations_set_elasticity_fluid_pres_holmes_mow_active_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_holmes_mow_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_static_inria_subtype, equations_set_constants::equations_set_fd_solution_method, equations_set_constants::equations_set_fem_solution_method, equations_set_constants::equations_set_fv_solution_method, equations_set_constants::equations_set_gfem_solution_method, equations_set_constants::equations_set_gfv_solution_method, equations_set_constants::equations_set_guccione_activecontraction_subtype, equations_set_constants::equations_set_holzapfel_ogden_activecontraction_subtype, equations_set_constants::equations_set_incompressible_elast_multi_comp_darcy_subtype, equations_set_constants::equations_set_incompressible_elasticity_driven_darcy_subtype, equations_set_constants::equations_set_incompressible_finite_elasticity_darcy_subtype, equations_set_constants::equations_set_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_isotropic_exponential_subtype, equations_set_constants::equations_set_membrane_subtype, equations_set_constants::equations_set_monodomain_elasticity_velocity_subtype, equations_set_constants::equations_set_monodomain_elasticity_w_titin_subtype, equations_set_constants::equations_set_mooney_rivlin_activecontraction_subtype, equations_set_constants::equations_set_mooney_rivlin_subtype, equations_set_constants::equations_set_multiscale_active_strain_subtype, equations_set_constants::equations_set_nearly_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_no_subtype, equations_set_constants::equations_set_orthotropic_material_costa_subtype, equations_set_constants::equations_set_orthotropic_material_holzapfel_ogden_subtype, equations_set_constants::equations_set_standard_monodomain_elasticity_subtype, equations_set_constants::equations_set_stvenant_kirchoff_activecontraction_subtype, equations_set_constants::equations_set_trans_isotropic_active_transition_subtype, equations_set_constants::equations_set_transverse_isotropic_active_subtype, equations_set_constants::equations_set_transverse_isotropic_exponential_subtype, equations_set_constants::equations_set_transverse_isotropic_guccione_subtype, equations_set_constants::equations_set_transverse_isotropic_humphrey_yin_subtype, equations_set_constants::equations_set_transverse_isotropic_polynomial_subtype, base_routines::errors(), and base_routines::exits().

Referenced by elasticity_routines::elasticity_equationssetsolutionmethodset(), and finite_elasticity_equations_set_setup().

subroutine, public finite_elasticity_routines::finiteelasticity_equationssetspecificationset ( type(equations_set_type), pointer  equationsSet,
integer(intg), dimension(:), intent(in)  specification,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)

Sets the equation specification for a finite elasticity equation type of an elasticity equations set class.

Parameters
equationssetA pointer to the equations set to set the equation subtype for
[in]specificationThe equations set specification to set
[out]errThe error code
[out]errorThe error string

Definition at line 8550 of file finite_elasticity_routines.f90.

References base_routines::enters(), equations_set_constants::equations_set_1d3d_monodomain_active_strain_subtype, equations_set_constants::equations_set_1d3d_monodomain_elasticity_subtype, equations_set_constants::equations_set_active_strain_subtype, equations_set_constants::equations_set_activecontraction_subtype, equations_set_constants::equations_set_anisotropic_polynomial_active_subtype, equations_set_constants::equations_set_anisotropic_polynomial_subtype, equations_set_constants::equations_set_compressible_activecontraction_subtype, equations_set_constants::equations_set_compressible_finite_elasticity_subtype, equations_set_constants::equations_set_constitutive_and_growth_law_in_cellml_subtype, equations_set_constants::equations_set_constitutive_law_in_cellml_evaluate_subtype, equations_set_constants::equations_set_elasticity_class, equations_set_constants::equations_set_elasticity_darcy_inria_model_subtype, equations_set_constants::equations_set_elasticity_fluid_pres_holmes_mow_active_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_holmes_mow_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_static_inria_subtype, equations_set_constants::equations_set_finite_elasticity_type, equations_set_constants::equations_set_guccione_activecontraction_subtype, equations_set_constants::equations_set_holzapfel_ogden_activecontraction_subtype, equations_set_constants::equations_set_incompressible_elast_multi_comp_darcy_subtype, equations_set_constants::equations_set_incompressible_elasticity_driven_darcy_subtype, equations_set_constants::equations_set_incompressible_finite_elasticity_darcy_subtype, equations_set_constants::equations_set_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_isotropic_exponential_subtype, equations_set_constants::equations_set_membrane_subtype, equations_set_constants::equations_set_monodomain_elasticity_velocity_subtype, equations_set_constants::equations_set_monodomain_elasticity_w_titin_subtype, equations_set_constants::equations_set_mooney_rivlin_activecontraction_subtype, equations_set_constants::equations_set_mooney_rivlin_subtype, equations_set_constants::equations_set_multiscale_active_strain_subtype, equations_set_constants::equations_set_nearly_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_no_subtype, equations_set_constants::equations_set_orthotropic_material_costa_subtype, equations_set_constants::equations_set_orthotropic_material_holzapfel_ogden_subtype, equations_set_constants::equations_set_standard_monodomain_elasticity_subtype, equations_set_constants::equations_set_stvenant_kirchoff_activecontraction_subtype, equations_set_constants::equations_set_trans_isotropic_active_transition_subtype, equations_set_constants::equations_set_transverse_isotropic_active_subtype, equations_set_constants::equations_set_transverse_isotropic_exponential_subtype, equations_set_constants::equations_set_transverse_isotropic_guccione_subtype, equations_set_constants::equations_set_transverse_isotropic_humphrey_yin_subtype, equations_set_constants::equations_set_transverse_isotropic_polynomial_subtype, base_routines::errors(), and base_routines::exits().

Referenced by elasticity_routines::elasticity_equationssetspecificationset().

subroutine, public finite_elasticity_routines::finiteelasticity_finiteelementjacobianevaluate ( type(equations_set_type), pointer  EQUATIONS_SET,
integer(intg), intent(in)  ELEMENT_NUMBER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
subroutine, public finite_elasticity_routines::finiteelasticity_finiteelementpostresidualevaluate ( type(equations_set_type), pointer  EQUATIONS_SET,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Post-evaluates the residual for a finite elasticity finite element equations set.

Parameters
equations_setA pointer to the equations set
[out]errThe error code
[out]errorThe error string

Definition at line 2643 of file finite_elasticity_routines.f90.

References base_routines::enters(), equations_set_constants::equations_set_1d3d_monodomain_active_strain_subtype, equations_set_constants::equations_set_1d3d_monodomain_elasticity_subtype, equations_set_constants::equations_set_active_strain_subtype, equations_set_constants::equations_set_activecontraction_subtype, equations_set_constants::equations_set_anisotropic_polynomial_active_subtype, equations_set_constants::equations_set_anisotropic_polynomial_subtype, equations_set_constants::equations_set_compressible_activecontraction_subtype, equations_set_constants::equations_set_compressible_finite_elasticity_subtype, equations_set_constants::equations_set_constitutive_and_growth_law_in_cellml_subtype, equations_set_constants::equations_set_constitutive_law_in_cellml_evaluate_subtype, equations_set_constants::equations_set_elasticity_darcy_inria_model_subtype, equations_set_constants::equations_set_elasticity_fluid_pres_holmes_mow_active_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_holmes_mow_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_static_inria_subtype, equations_set_constants::equations_set_guccione_activecontraction_subtype, equations_set_constants::equations_set_holzapfel_ogden_activecontraction_subtype, equations_set_constants::equations_set_incompressible_elast_multi_comp_darcy_subtype, equations_set_constants::equations_set_incompressible_elasticity_driven_darcy_subtype, equations_set_constants::equations_set_incompressible_finite_elasticity_darcy_subtype, equations_set_constants::equations_set_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_isotropic_exponential_subtype, equations_set_constants::equations_set_membrane_subtype, equations_set_constants::equations_set_monodomain_elasticity_velocity_subtype, equations_set_constants::equations_set_monodomain_elasticity_w_titin_subtype, equations_set_constants::equations_set_mooney_rivlin_activecontraction_subtype, equations_set_constants::equations_set_mooney_rivlin_subtype, equations_set_constants::equations_set_multiscale_active_strain_subtype, equations_set_constants::equations_set_nearly_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_no_subtype, equations_set_constants::equations_set_orthotropic_material_costa_subtype, equations_set_constants::equations_set_orthotropic_material_holzapfel_ogden_subtype, equations_set_constants::equations_set_standard_monodomain_elasticity_subtype, equations_set_constants::equations_set_stvenant_kirchoff_activecontraction_subtype, equations_set_constants::equations_set_trans_isotropic_active_transition_subtype, equations_set_constants::equations_set_transverse_isotropic_active_subtype, equations_set_constants::equations_set_transverse_isotropic_exponential_subtype, equations_set_constants::equations_set_transverse_isotropic_guccione_subtype, equations_set_constants::equations_set_transverse_isotropic_humphrey_yin_subtype, equations_set_constants::equations_set_transverse_isotropic_polynomial_subtype, base_routines::errors(), and base_routines::exits().

Referenced by elasticity_routines::elasticity_finiteelementpostresidualevaluate().

subroutine, public finite_elasticity_routines::finiteelasticity_finiteelementpreresidualevaluate ( type(equations_set_type), pointer  EQUATIONS_SET,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Pre-evaluates the residual for a finite elasticity finite element equations set.

Parameters
equations_setA pointer to the equations set
[out]errThe error code
[out]errorThe error string

Definition at line 2569 of file finite_elasticity_routines.f90.

References base_routines::enters(), equations_set_constants::equations_set_1d3d_monodomain_active_strain_subtype, equations_set_constants::equations_set_1d3d_monodomain_elasticity_subtype, equations_set_constants::equations_set_active_strain_subtype, equations_set_constants::equations_set_activecontraction_subtype, equations_set_constants::equations_set_anisotropic_polynomial_active_subtype, equations_set_constants::equations_set_anisotropic_polynomial_subtype, equations_set_constants::equations_set_compressible_activecontraction_subtype, equations_set_constants::equations_set_compressible_finite_elasticity_subtype, equations_set_constants::equations_set_constitutive_and_growth_law_in_cellml_subtype, equations_set_constants::equations_set_constitutive_law_in_cellml_evaluate_subtype, equations_set_constants::equations_set_elasticity_darcy_inria_model_subtype, equations_set_constants::equations_set_elasticity_fluid_pres_holmes_mow_active_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_holmes_mow_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_static_inria_subtype, equations_set_constants::equations_set_guccione_activecontraction_subtype, equations_set_constants::equations_set_holzapfel_ogden_activecontraction_subtype, equations_set_constants::equations_set_incompressible_elast_multi_comp_darcy_subtype, equations_set_constants::equations_set_incompressible_elasticity_driven_darcy_subtype, equations_set_constants::equations_set_incompressible_finite_elasticity_darcy_subtype, equations_set_constants::equations_set_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_isotropic_exponential_subtype, equations_set_constants::equations_set_membrane_subtype, equations_set_constants::equations_set_monodomain_elasticity_velocity_subtype, equations_set_constants::equations_set_monodomain_elasticity_w_titin_subtype, equations_set_constants::equations_set_mooney_rivlin_activecontraction_subtype, equations_set_constants::equations_set_mooney_rivlin_subtype, equations_set_constants::equations_set_multiscale_active_strain_subtype, equations_set_constants::equations_set_nearly_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_no_subtype, equations_set_constants::equations_set_orthotropic_material_costa_subtype, equations_set_constants::equations_set_orthotropic_material_holzapfel_ogden_subtype, equations_set_constants::equations_set_standard_monodomain_elasticity_subtype, equations_set_constants::equations_set_stvenant_kirchoff_activecontraction_subtype, equations_set_constants::equations_set_trans_isotropic_active_transition_subtype, equations_set_constants::equations_set_transverse_isotropic_active_subtype, equations_set_constants::equations_set_transverse_isotropic_exponential_subtype, equations_set_constants::equations_set_transverse_isotropic_guccione_subtype, equations_set_constants::equations_set_transverse_isotropic_humphrey_yin_subtype, equations_set_constants::equations_set_transverse_isotropic_polynomial_subtype, base_routines::errors(), base_routines::exits(), and finiteelasticity_straincalculate().

Referenced by elasticity_routines::elasticity_finiteelementpreresidualevaluate().

subroutine, public finite_elasticity_routines::finiteelasticity_finiteelementresidualevaluate ( type(equations_set_type), pointer  EQUATIONS_SET,
integer(intg), intent(in)  ELEMENT_NUMBER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Evaluates the residual and RHS vectors for a finite elasticity finite element equations set.

Parameters
equations_setA pointer to the equations set
[in]element_numberThe element number to calculate
[out]errThe error code
[out]errorThe error string

Definition at line 1423 of file finite_elasticity_routines.f90.

References basis_routines::basis_default_quadrature_scheme, boundary_conditions_routines::boundary_condition_pressure, boundary_conditions_routines::boundary_condition_pressure_incremented, boundary_conditions_routines::boundary_conditions_variable_get(), base_routines::diagnostic_output_type, base_routines::diagnostics1, base_routines::diagnostics5, base_routines::enters(), equations_set_constants::equations_set_1d3d_monodomain_active_strain_subtype, equations_set_constants::equations_set_1d3d_monodomain_elasticity_subtype, equations_set_constants::equations_set_active_strain_subtype, equations_set_constants::equations_set_activecontraction_subtype, equations_set_constants::equations_set_anisotropic_polynomial_active_subtype, equations_set_constants::equations_set_anisotropic_polynomial_subtype, equations_set_constants::equations_set_compressible_activecontraction_subtype, equations_set_constants::equations_set_compressible_finite_elasticity_subtype, equations_set_constants::equations_set_constitutive_and_growth_law_in_cellml_subtype, equations_set_constants::equations_set_constitutive_law_in_cellml_evaluate_subtype, equations_set_constants::equations_set_elasticity_darcy_inria_model_subtype, equations_set_constants::equations_set_elasticity_fluid_pres_holmes_mow_active_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_holmes_mow_subtype, equations_set_constants::equations_set_elasticity_fluid_pressure_static_inria_subtype, equations_set_constants::equations_set_guccione_activecontraction_subtype, equations_set_constants::equations_set_holzapfel_ogden_activecontraction_subtype, equations_set_constants::equations_set_incompressible_elast_multi_comp_darcy_subtype, equations_set_constants::equations_set_incompressible_elasticity_driven_darcy_subtype, equations_set_constants::equations_set_incompressible_finite_elasticity_darcy_subtype, equations_set_constants::equations_set_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_isotropic_exponential_subtype, equations_set_constants::equations_set_membrane_subtype, equations_set_constants::equations_set_monodomain_elasticity_velocity_subtype, equations_set_constants::equations_set_monodomain_elasticity_w_titin_subtype, equations_set_constants::equations_set_mooney_rivlin_activecontraction_subtype, equations_set_constants::equations_set_mooney_rivlin_subtype, equations_set_constants::equations_set_multiscale_active_strain_subtype, equations_set_constants::equations_set_nearly_incompressible_mooney_rivlin_subtype, equations_set_constants::equations_set_no_subtype, equations_set_constants::equations_set_orthotropic_material_costa_subtype, equations_set_constants::equations_set_orthotropic_material_holzapfel_ogden_subtype, equations_set_constants::equations_set_standard_monodomain_elasticity_subtype, equations_set_constants::equations_set_stvenant_kirchoff_activecontraction_subtype, equations_set_constants::equations_set_trans_isotropic_active_transition_subtype, equations_set_constants::equations_set_transverse_isotropic_active_subtype, equations_set_constants::equations_set_transverse_isotropic_exponential_subtype, equations_set_constants::equations_set_transverse_isotropic_guccione_subtype, equations_set_constants::equations_set_transverse_isotropic_humphrey_yin_subtype, equations_set_constants::equations_set_transverse_isotropic_polynomial_subtype, base_routines::errors(), base_routines::exits(), finite_elasticity_gauss_cauchy_tensor(), finite_elasticity_gauss_dfdz(), finite_elasticity_gauss_stress_tensor(), finiteelasticity_gaussdeformationgradienttensor(), finiteelasticity_gaussgrowthtensor(), finiteelasticity_straintensor(), finiteelasticity_surfacepressureresidualevaluate(), constants::first_part_deriv, get_darcy_finite_elasticity_parameters(), constants::no_part_deriv, constants::partial_derivative_first_derivative_map, fluid_mechanics_io_routines::source_interpolated_point, fluid_mechanics_io_routines::source_interpolation_parameters, constants::tensor_to_voigt3, and input_output::write_string_matrix_name_and_indices.

Referenced by elasticity_routines::elasticity_finite_element_residual_evaluate().

subroutine, public finite_elasticity_routines::finiteelasticity_gaussdeformationgradienttensor ( type(field_interpolated_point_metrics_type), pointer  dependentInterpPointMetrics,
type(field_interpolated_point_metrics_type), pointer  geometricInterpPointMetrics,
type(field_interpolated_point_type), pointer  fibreInterpolatedPoint,
real(dp), dimension(3,3), intent(out)  dZdNu,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)
subroutine finite_elasticity_routines::finiteelasticity_gaussgrowthtensor ( type(equations_set_type), intent(in), pointer  equationsSet,
integer(intg), intent(in)  numberOfDimensions,
integer(intg), intent(in)  gaussPointNumber,
integer(intg), intent(in)  elementNumber,
type(field_type), pointer  dependentField,
real(dp), dimension(3,3), intent(in)  deformationGradientTensor,
real(dp), dimension(3,3), intent(out)  growthTensor,
real(dp), dimension(3,3), intent(out)  elasticDeformationGradientTensor,
real(dp), intent(out)  Jg,
real(dp), intent(out)  Je,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)
private

Evaluates the growth tensor at a given Gauss point and calculates the elastic part of the deformation gradient tensor.

Parameters
[in]equationssetA pointer to the equations set
[in]numberofdimensionsThe number of dimensions
[in]gausspointnumberThe Gauss point number to evaluate the growth tensor at
[in]elementnumberThe element number to evaluate the growth tensor at
dependentfieldA pointer to the dependent field
[in]deformationgradienttensorThe full deformation gradient tensor
[out]growthtensorOn output, the growth tensor
[out]elasticdeformationgradienttensorOn output, the elastic part of the deformation gradient tensor
[out]jgOn output, the Jacobian of the growth tensor
[out]jeOn output, the Jacobian of the elastic tensor
[out]errThe error code
[out]errorThe error string

Definition at line 1305 of file finite_elasticity_routines.f90.

References base_routines::diagnostic_output_type, base_routines::diagnostics1, base_routines::enters(), base_routines::exits(), and input_output::write_string_matrix_name_and_indices.

Referenced by finiteelasticity_finiteelementresidualevaluate(), and finiteelasticity_straincalculate().

subroutine finite_elasticity_routines::finiteelasticity_gaussgrowthtensor_newer123 ( type(equations_set_type), intent(in), pointer  equationsSet,
integer(intg), intent(in)  numberOfDimensions,
integer(intg), intent(in)  gaussPointNumber,
integer(intg), intent(in)  elementNumber,
type(field_type), pointer  dependentField,
real(dp), dimension(3,3), intent(in)  deformationGradientTensor,
real(dp), dimension(3,3), intent(out)  growthTensor,
real(dp), dimension(3,3), intent(out)  elasticDeformationGradientTensor,
real(dp), intent(out)  Jg,
real(dp), intent(out)  Je,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)
private

Evaluates the growth tensor at a given Gauss point and calculates the elastic part of the deformation gradient tensor.

Parameters
[in]equationssetA pointer to the equations set
[in]numberofdimensionsThe number of dimensions
[in]gausspointnumberThe Gauss point number to evaluate the growth tensor at
[in]elementnumberThe element number to evaluate the growth tensor at
dependentfieldA pointer to the dependent field
[in]deformationgradienttensorThe full deformation gradient tensor
[out]growthtensorOn output, the growth tensor
[out]elasticdeformationgradienttensorOn output, the elastic part of the deformation gradient tensor
[out]jgOn output, the Jacobian of the growth tensor
[out]jeOn output, the Jacobian of the elastic tensor
[out]errThe error code
[out]errorThe error string

Definition at line 5320 of file finite_elasticity_routines.f90.

References base_routines::diagnostic_output_type, base_routines::diagnostics1, base_routines::enters(), equations_set_constants::equations_set_constitutive_and_growth_law_in_cellml_subtype, base_routines::exits(), and input_output::write_string_matrix_name_and_indices.

subroutine finite_elasticity_routines::finiteelasticity_piolaaddactivecontraction ( type(field_type), intent(in), pointer  INDEPENDENT_FIELD,
type(field_type), intent(in), pointer  MATERIALS_FIELD,
real(dp), intent(inout)  PIOLA_FF,
real(dp), intent(in)  E_FF,
integer(intg), intent(in)  ELEMENT_NUMBER,
integer(intg), intent(in)  GAUSS_POINT_NUMBER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private
Parameters
[in,out]piola_ffThe (1,1)=(fiber,fiber) component of the stress tensor
[in]e_ffE(1,1)
[in]gauss_point_numberElement/Gauss point number
[out]errThe error code
[out]errorThe error string

Definition at line 5574 of file finite_elasticity_routines.f90.

References kinds::dp, base_routines::enters(), base_routines::exits(), and finite_elasticity_fmm().

Referenced by finite_elasticity_gauss_cauchy_tensor().

subroutine finite_elasticity_routines::finiteelasticity_presolvegetsoliddisplacement ( type(control_loop_type), pointer  CONTROL_LOOP,
type(solver_type), pointer  SOLVER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private
subroutine finite_elasticity_routines::finiteelasticity_presolveupdateboundaryconditions ( type(control_loop_type), pointer  CONTROL_LOOP,
type(solver_type), pointer  SOLVER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private
subroutine, public finite_elasticity_routines::finiteelasticity_problemspecificationset ( type(problem_type), pointer  problem,
integer(intg), dimension(:), intent(in)  problemSpecification,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)
subroutine, public finite_elasticity_routines::finiteelasticity_straincalculate ( type(equations_set_type), intent(in), pointer  equationsSet,
type(field_type), intent(inout), pointer  strainField,
integer(intg), intent(in)  strainFieldVariableType,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)

Calculates the strain field for a finite elasticity finite element equations set.

Parameters
[in]equationssetA pointer to the equations set to calculate strain for
[in,out]strainfieldThe field to store the strain in.
[in]strainfieldvariabletypeThe field variable type of the output field to store the strain in.
[out]errThe error code
[out]errorThe error string

Definition at line 2763 of file finite_elasticity_routines.f90.

References basis_routines::basis_default_quadrature_scheme, timer::cpu_timer(), base_routines::diagnostic_output_type, base_routines::diagnostics1, base_routines::enters(), equations_routines::equations_timing_output, base_routines::exits(), finiteelasticity_gaussdeformationgradienttensor(), finiteelasticity_gaussgrowthtensor(), finiteelasticity_straintensor(), constants::first_part_deriv, base_routines::general_output_type, fluid_mechanics_io_routines::numberofdimensions, timer::system_cpu, and timer::user_cpu.

Referenced by finite_elasticity_pre_solve(), finiteelasticity_finiteelementpreresidualevaluate(), and finiteelasticityequationsset_derivedvariablecalculate().

subroutine finite_elasticity_routines::finiteelasticity_straintensor ( real(dp), dimension(3,3), intent(in)  deformationGradientTensor,
real(dp), dimension(3,3), intent(out)  rightCauchyDeformationTensor,
real(dp), dimension(3,3), intent(out)  fingerDeformationTensor,
real(dp), intent(out)  Jacobian,
real(dp), dimension(3,3), intent(out)  greenStrainTensor,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)
private

Evaluates the strain tensor given the deformation gradient tensor.

Parameters
[in]deformationgradienttensorThe elastic part of the deformation gradient tensor
[out]rightcauchydeformationtensorOn output, the right Cauchy deformation tensor, C
[out]fingerdeformationtensorOn output, the finger deformation tensor, f
[out]jacobianOn output, the Jacobian of the deformation
[out]greenstraintensorOn output, the Green-Lagrange strain tensor
[out]errThe error code
[out]errorThe error string

Definition at line 1365 of file finite_elasticity_routines.f90.

References base_routines::diagnostic_output_type, base_routines::diagnostics1, base_routines::enters(), base_routines::exits(), and input_output::write_string_matrix_name_and_indices.

Referenced by finiteelasticity_finiteelementresidualevaluate(), and finiteelasticity_straincalculate().

subroutine finite_elasticity_routines::finiteelasticity_straintensor_newer123 ( real(dp), dimension(3,3), intent(in)  deformationGradientTensor,
real(dp), dimension(3,3), intent(out)  rightCauchyDeformationTensor,
real(dp), dimension(3,3), intent(out)  fingerDeformationTensor,
real(dp), intent(out)  Jacobian,
real(dp), dimension(3,3), intent(out)  greenStrainTensor,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)
private

Evaluates the strain tensor given the deformation gradient tensor.

Parameters
[in]deformationgradienttensorThe elastic part of the deformation gradient tensor
[out]rightcauchydeformationtensorOn output, the right Cauchy deformation tensor, C
[out]fingerdeformationtensorOn output, the finger deformation tensor, f
[out]jacobianOn output, the Jacobian of the deformation
[out]greenstraintensorOn output, the Green-Lagrange strain tensor
[out]errThe error code
[out]errorThe error string

Definition at line 5398 of file finite_elasticity_routines.f90.

References base_routines::diagnostic_output_type, base_routines::diagnostics1, fluid_mechanics_io_routines::element_number, base_routines::enters(), base_routines::exits(), and input_output::write_string_matrix_name_and_indices.

subroutine finite_elasticity_routines::finiteelasticity_surfacepressurejacobianevaluate ( type(equations_set_type), pointer  EQUATIONS_SET,
integer(intg), intent(in)  ELEMENT_NUMBER,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private
subroutine finite_elasticity_routines::finiteelasticity_surfacepressureresidualevaluate ( type(equations_set_type), pointer  EQUATIONS_SET,
integer(intg), intent(in)  ELEMENT_NUMBER,
integer(intg), intent(in)  var1,
integer(intg), intent(in)  var2,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)
private
Parameters
equations_setA pointer to the equations set
[in]var1'U' variable number in single-physics case
[in]var2'DELUDELN' variable number in single-physics case
[out]errThe error code
[out]errorThe error string

Definition at line 3441 of file finite_elasticity_routines.f90.

References basis_routines::basis_default_quadrature_scheme, coordinate_routines::coordinate_jacobian_area_type, base_routines::enters(), base_routines::errors(), base_routines::exits(), constants::first_part_deriv, constants::no_part_deriv, constants::other_xi_directions3, constants::other_xi_orientations3, and constants::zero_tolerance.

Referenced by finiteelasticity_finiteelementresidualevaluate().

subroutine, public finite_elasticity_routines::finiteelasticity_tensorinterpolatexi ( type(equations_set_type), intent(in), pointer  equationsSet,
integer(intg), intent(in)  tensorEvaluateType,
integer(intg), intent(in)  userElementNumber,
real(dp), dimension(:), intent(in)  xi,
real(dp), dimension(3,3), intent(out)  values,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)
subroutine, public finite_elasticity_routines::finiteelasticityequationsset_derivedvariablecalculate ( type(equations_set_type), intent(in), pointer  equationsSet,
integer(intg), intent(in)  derivedType,
integer(intg), intent(out)  err,
type(varying_string), intent(out)  error 
)

Calculated an output field for a finite elasticity equations set.

Parameters
[in]equationssetA pointer to the equations set to calculate the output for
[in]derivedtypeThe derived field type to calculate.
See also
EQUATIONS_SET_CONSTANTS::DerivedTypes.
Parameters
[out]errThe error code
[out]errorThe error string

Definition at line 2712 of file finite_elasticity_routines.f90.

References base_routines::enters(), equations_routines::equations_derivedvariableget(), equations_set_constants::equations_set_derived_strain, equations_set_constants::equations_set_derived_stress, base_routines::errors(), base_routines::exits(), and finiteelasticity_straincalculate().

Referenced by elasticity_routines::elasticity_equationssetderivedvariablecalculate().

subroutine, public finite_elasticity_routines::get_darcy_finite_elasticity_parameters ( real(dp), intent(out)  DARCY_RHO_0_F,
real(dp), intent(out)  Mfact,
real(dp), intent(out)  bfact,
real(dp), intent(out)  p0fact,
integer(intg), intent(out)  ERR,
type(varying_string), intent(out)  ERROR 
)

Sets some data for the coupled Darcy / finite-elasticity model.

Parameters
[out]errThe error code
[out]errorThe error string

Definition at line 10917 of file finite_elasticity_routines.f90.

References base_routines::enters(), and base_routines::exits().

Referenced by darcy_equations_routines::darcy_equation_finite_element_calculate(), evaluate_chapelle_piola_tensor_addition(), and finiteelasticity_finiteelementresidualevaluate().