v0.15.0
Loading...
Searching...
No Matches
Classes | Macros | Typedefs | Functions | Variables
thermo_elastic.cpp File Reference
#include <MoFEM.hpp>
#include <MatrixFunction.hpp>
#include <ThermalConvection.hpp>
#include <ThermalRadiation.hpp>
#include <HenckyOps.hpp>
#include <FiniteThermalOps.hpp>
#include <ThermalOps.hpp>
#include <ThermoElasticOps.hpp>

Go to the source code of this file.

Classes

struct  ThermoElasticProblem
 
struct  ThermoElasticProblem::BlockedThermalParameters
 
struct  ThermoElasticProblem::BlockedThermoElasticParameters
 

Macros

#define EXECUTABLE_DIMENSION   3
 
#define FINITE_DEFORMATION_FLAG   true
 
#define EXECUTABLE_DIMENSION   3
 

Typedefs

using EntData = EntitiesFieldData::EntData
 
using DomainEle = PipelineManager::ElementsAndOpsByDim< SPACE_DIM >::DomainEle
 
using DomainEleOp = DomainEle::UserDataOperator
 
using BoundaryEle = PipelineManager::ElementsAndOpsByDim< SPACE_DIM >::BoundaryEle
 
using BoundaryEleOp = BoundaryEle::UserDataOperator
 
using PostProcEle = PostProcBrokenMeshInMoab< DomainEle >
 
using SkinPostProcEle = PostProcBrokenMeshInMoab< BoundaryEle >
 
using SideEle = PipelineManager::ElementsAndOpsByDim< SPACE_DIM >::FaceSideEle
 
using AssemblyDomainEleOp = FormsIntegrators< DomainEleOp >::Assembly< PETSC >::OpBase
 
using DomainNaturalBCRhs = NaturalBC< DomainEleOp >::Assembly< PETSC >::LinearForm< GAUSS >
 [Thermal problem]
 
using OpBodyForce = DomainNaturalBCRhs::OpFlux< NaturalMeshsetType< BLOCKSET >, 1, SPACE_DIM >
 
using OpHeatSource = DomainNaturalBCRhs::OpFlux< NaturalMeshsetType< BLOCKSET >, 1, 1 >
 
using DomainNaturalBCLhs = NaturalBC< DomainEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >
 
using BoundaryNaturalBC = NaturalBC< BoundaryEleOp >::Assembly< PETSC >::LinearForm< GAUSS >
 [Body and heat source]
 
using OpForce = BoundaryNaturalBC::OpFlux< NaturalForceMeshsets, 1, SPACE_DIM >
 
using OpEssentialFluxRhs = EssentialBC< BoundaryEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpEssentialRhs< HeatFluxCubitBcData, 3, SPACE_DIM >
 [Natural boundary conditions]
 
using OpEssentialFluxLhs = EssentialBC< BoundaryEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpEssentialLhs< HeatFluxCubitBcData, 3, SPACE_DIM >
 
using OpSetTemperatureRhs = DomainNaturalBCRhs::OpFlux< SetTargetTemperature, 1, 1 >
 
using OpSetTemperatureLhs = DomainNaturalBCLhs::OpFlux< SetTargetTemperature, 1, 1 >
 

Functions

int main (int argc, char *argv[])
 

Variables

constexpr int SPACE_DIM
 
constexpr bool IS_LARGE_STRAINS
 
constexpr AssemblyType AT = AssemblyType::PETSC
 
constexpr IntegrationType IT
 
double default_young_modulus = 1
 [Essential boundary conditions (Least square approach)]
 
double default_poisson_ratio = 0.25
 
double default_ref_temp = 0.0
 
double default_init_temp = 0.0
 
double default_coeff_expansion = 1
 
double default_heat_conductivity
 
double default_heat_capacity = 1
 
int order_temp = 2
 
int order_flux = 3
 
int order_disp = 3
 
int atom_test = 0
 
int save_every = 1
 
PetscBool do_output_domain
 
PetscBool do_output_skin
 
auto save_range
 
static char help [] = "...\n\n"
 [Solve]
 
static char help [] = "...\n\n"
 [Solve]
 

Macro Definition Documentation

◆ EXECUTABLE_DIMENSION [1/2]

#define EXECUTABLE_DIMENSION   3

Definition at line 10 of file thermo_elastic.cpp.

◆ EXECUTABLE_DIMENSION [2/2]

#define EXECUTABLE_DIMENSION   3

Definition at line 10 of file thermo_elastic.cpp.

◆ FINITE_DEFORMATION_FLAG

#define FINITE_DEFORMATION_FLAG   true

Typedef Documentation

◆ AssemblyDomainEleOp

Definition at line 41 of file thermo_elastic.cpp.

◆ BoundaryEle

Definition at line 34 of file thermo_elastic.cpp.

◆ BoundaryEleOp

Definition at line 36 of file thermo_elastic.cpp.

◆ BoundaryNaturalBC

typedef NaturalBC< BoundaryEleOp >::Assembly< PETSC >::LinearForm< GAUSS > BoundaryNaturalBC

[Body and heat source]

[Natural boundary conditions]

Definition at line 74 of file thermo_elastic.cpp.

◆ DomainEle

Definition at line 32 of file thermo_elastic.cpp.

◆ DomainEleOp

Definition at line 33 of file thermo_elastic.cpp.

◆ DomainNaturalBCLhs

typedef NaturalBC< DomainEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS > DomainNaturalBCLhs

Definition at line 69 of file thermo_elastic.cpp.

◆ DomainNaturalBCRhs

typedef NaturalBC< DomainEleOp >::Assembly< PETSC >::LinearForm< GAUSS > DomainNaturalBCRhs

[Thermal problem]

[Body and heat source]

Definition at line 63 of file thermo_elastic.cpp.

◆ EntData

Definition at line 31 of file thermo_elastic.cpp.

◆ OpBodyForce

Definition at line 65 of file thermo_elastic.cpp.

◆ OpEssentialFluxLhs

typedef EssentialBC< BoundaryEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpEssentialLhs< HeatFluxCubitBcData, 3, SPACE_DIM > OpEssentialFluxLhs

Definition at line 84 of file thermo_elastic.cpp.

◆ OpEssentialFluxRhs

typedef EssentialBC< BoundaryEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpEssentialRhs< HeatFluxCubitBcData, 3, SPACE_DIM > OpEssentialFluxRhs

[Natural boundary conditions]

[Essential boundary conditions (Least square approach)]

Definition at line 81 of file thermo_elastic.cpp.

◆ OpForce

Definition at line 76 of file thermo_elastic.cpp.

◆ OpHeatSource

Definition at line 67 of file thermo_elastic.cpp.

◆ OpSetTemperatureLhs

typedef DomainNaturalBCLhs::OpFlux< SetTargetTemperature, 1, 1 > OpSetTemperatureLhs

Definition at line 118 of file thermo_elastic.cpp.

◆ OpSetTemperatureRhs

typedef DomainNaturalBCRhs::OpFlux< SetTargetTemperature, 1, 1 > OpSetTemperatureRhs

Definition at line 116 of file thermo_elastic.cpp.

◆ PostProcEle

Definition at line 37 of file thermo_elastic.cpp.

◆ SideEle

Definition at line 39 of file thermo_elastic.cpp.

◆ SkinPostProcEle

Definition at line 38 of file thermo_elastic.cpp.

Function Documentation

◆ main()

int main ( int  argc,
char *  argv[] 
)

[Register MoFEM discrete manager in PETSc]

[Register MoFEM discrete manager in PETSc

[Create MoAB]

< mesh database

< mesh database interface

[Create MoAB]

[Create MoFEM]

< finite element database

< finite element database interface

[Create MoFEM]

[Load mesh]

[Load mesh]

[ThermoElasticProblem]

[ThermoElasticProblem]

[Register MoFEM discrete manager in PETSc]

[Register MoFEM discrete manager in PETSc

[Create MoAB]

< mesh database

< mesh database interface

[Create MoAB]

[Create MoFEM]

< finite element database

< finite element database interface

[Create MoFEM]

[Load mesh]

[Load mesh]

[ThermoElasticProblem]

[ThermoElasticProblem]

Definition at line 1715 of file thermo_elastic.cpp.

1729 {
1730
1731 //! [Register MoFEM discrete manager in PETSc]
1732 DMType dm_name = "DMMOFEM";
1733 CHKERR DMRegister_MoFEM(dm_name);
1734 //! [Register MoFEM discrete manager in PETSc
1735
1736 //! [Create MoAB]
1737 moab::Core mb_instance; ///< mesh database
1738 moab::Interface &moab = mb_instance; ///< mesh database interface
1739 //! [Create MoAB]
1740
1741 //! [Create MoFEM]
1742 MoFEM::Core core(moab); ///< finite element database
1743 MoFEM::Interface &m_field = core; ///< finite element database interface
1744 //! [Create MoFEM]
1745
1746 //! [Load mesh]
1747 Simple *simple = m_field.getInterface<Simple>();
1749 CHKERR simple->loadFile();
1750 //! [Load mesh]
1751
1752 //! [ThermoElasticProblem]
1753 ThermoElasticProblem ex(m_field);
1754 CHKERR ex.runProblem();
1755 //! [ThermoElasticProblem]
1756 }
1758
1760}
void simple(double P1[], double P2[], double P3[], double c[], const int N)
Definition acoustic.cpp:69
#define CATCH_ERRORS
Catch errors.
#define CHKERR
Inline error check.
PetscErrorCode DMRegister_MoFEM(const char sname[])
Register MoFEM problem.
Definition DMMoFEM.cpp:43
Core (interface) class.
Definition Core.hpp:82
static MoFEMErrorCode Finalize()
Checks for options to be called at the conclusion of the program.
Definition Core.cpp:118
Deprecated interface functions.
Simple interface for fast problem set-up.
Definition Simple.hpp:27
MoFEMErrorCode getOptions()
get options
Definition Simple.cpp:180
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.

Variable Documentation

◆ AT

constexpr AssemblyType AT = AssemblyType::PETSC
constexpr

Definition at line 44 of file thermo_elastic.cpp.

◆ atom_test

int atom_test = 0

◆ default_coeff_expansion

double default_coeff_expansion = 1

◆ default_heat_capacity

double default_heat_capacity = 1

◆ default_heat_conductivity

double default_heat_conductivity

◆ default_init_temp

double default_init_temp = 0.0

◆ default_poisson_ratio

double default_poisson_ratio = 0.25

◆ default_ref_temp

double default_ref_temp = 0.0

◆ default_young_modulus

double default_young_modulus = 1

[Essential boundary conditions (Least square approach)]

[Default input parameters]

Examples
mofem/tutorials/adv-2/thermo_elastic.cpp, mofem/tutorials/adv-5/seepage.cpp, and thermo_elastic.cpp.

Definition at line 90 of file thermo_elastic.cpp.

◆ do_output_domain

PetscBool do_output_domain

◆ do_output_skin

PetscBool do_output_skin

◆ help [1/2]

char help[] = "...\n\n"
static

[Solve]

Definition at line 1713 of file thermo_elastic.cpp.

◆ help [2/2]

char help[] = "...\n\n"
static

[Solve]

Definition at line 1709 of file thermo_elastic.cpp.

◆ IS_LARGE_STRAINS

constexpr bool IS_LARGE_STRAINS
constexpr

◆ IT

constexpr IntegrationType IT
constexpr
Initial value:
=
IntegrationType::GAUSS

Definition at line 45 of file thermo_elastic.cpp.

◆ order_disp

int order_disp = 3

◆ order_flux

int order_flux = 3

◆ order_temp

int order_temp = 2

◆ save_every

int save_every = 1

◆ save_range

auto save_range
Initial value:
= [](moab::Interface &moab, const std::string name,
const Range r) {
auto out_meshset = get_temp_meshset_ptr(moab);
CHKERR moab.add_entities(*out_meshset, r);
CHKERR moab.write_file(name.c_str(), "VTK", "", out_meshset->get_ptr(), 1);
}
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
auto get_temp_meshset_ptr(moab::Interface &moab)
Create smart pointer to temporary meshset.
Examples
mofem/tutorials/adv-2/thermo_elastic.cpp, mofem/tutorials/adv-3/level_set.cpp, mofem/tutorials/adv-5/seepage.cpp, mofem/tutorials/adv-6/between_meshes_dg_projection.cpp, mofem/tutorials/vec-5/free_surface.cpp, mofem/tutorials/vec-7/adjoint.cpp, mofem/users_modules/eshelbian_plasticity/src/impl/EshelbianPlasticity.cpp, thermo_elastic.cpp, and thermoplastic.cpp.

Definition at line 121 of file thermo_elastic.cpp.

126 {
127
128 ThermoElasticProblem(MoFEM::Interface &m_field) : mField(m_field) {}

◆ SPACE_DIM

constexpr int SPACE_DIM
constexpr
Initial value:
=
3
Examples
mofem/tutorials/adv-2/thermo_elastic.cpp, and thermo_elastic.cpp.

Definition at line 25 of file thermo_elastic.cpp.