|
| v0.14.0
|
- Examples
- wave_equation.cpp.
Definition at line 88 of file wave_equation.cpp.
◆ WaveEquation()
◆ assembleSystem()
- Examples
- wave_equation.cpp.
Definition at line 185 of file wave_equation.cpp.
188 auto add_domain_base_ops = [&](
auto &pipeline) {
189 auto det_ptr = boost::make_shared<VectorDouble>();
190 auto jac_ptr = boost::make_shared<MatrixDouble>();
191 auto inv_jac_ptr = boost::make_shared<MatrixDouble>();
198 auto add_domain_lhs_ops = [&](
auto &pipeline) {
201 "U",
"U", [](
double,
double,
double) ->
double {
return 1; }));
211 auto add_domain_rhs_ops = [&](
auto &pipeline) {
213 auto grad_u_at_gauss_pts = boost::make_shared<MatrixDouble>();
214 auto dot2_u_at_gauss_pts = boost::make_shared<VectorDouble>();
216 "U", grad_u_at_gauss_pts));
220 "U", grad_u_at_gauss_pts,
221 [](
double,
double,
double) ->
double {
return 1; }));
223 "U", dot2_u_at_gauss_pts,
224 [](
const double,
const double,
const double) {
return wave_speed2; }));
228 auto add_boundary_base_ops = [&](
auto &pipeline) {};
230 auto add_lhs_base_ops = [&](
auto &pipeline) {
233 "U",
"U", [](
const double,
const double,
const double) {
return 1; }));
237 auto add_rhs_base_ops = [&](
auto &pipeline) {
239 auto u_at_gauss_pts = boost::make_shared<VectorDouble>();
240 auto boundary_function = [&](
const double x,
const double y,
244 const double t = fe_rhs->ts_t;
245 if ((
t <= 0.5) && (x < 0.) && (y > -1. / 3) && (y < 1. / 3))
246 return sin(4 * M_PI *
t);
253 [](
const double,
const double,
const double) {
return 1; }));
259 add_domain_base_ops(pipeline_mng->getOpDomainLhsPipeline());
260 add_domain_base_ops(pipeline_mng->getOpDomainRhsPipeline());
261 add_domain_lhs_ops(pipeline_mng->getOpDomainLhsPipeline());
262 add_domain_rhs_ops(pipeline_mng->getOpDomainRhsPipeline());
264 add_boundary_base_ops(pipeline_mng->getOpBoundaryLhsPipeline());
265 add_boundary_base_ops(pipeline_mng->getOpBoundaryRhsPipeline());
266 add_lhs_base_ops(pipeline_mng->getOpBoundaryLhsPipeline());
267 add_rhs_base_ops(pipeline_mng->getOpBoundaryRhsPipeline());
◆ boundaryCondition()
- Examples
- wave_equation.cpp.
Definition at line 163 of file wave_equation.cpp.
168 CHKERR bc_mng->pushMarkDOFsOnEntities(
simple->getProblemName(),
"ESSENTIAL",
171 auto &bc_map = bc_mng->getBcMapByBlockName();
172 boundaryMarker = boost::make_shared<std::vector<char unsigned>>();
173 for (
auto b : bc_map) {
174 if (std::regex_match(b.first, std::regex(
"(.*)ESSENTIAL(.*)"))) {
176 for (
int i = 0;
i != b.second->bcMarkers.size(); ++
i) {
177 (*boundaryMarker)[
i] |= b.second->bcMarkers[
i];
◆ initialCondition()
◆ outputResults()
◆ readMesh()
◆ runProgram()
◆ setIntegrationRules()
◆ setupProblem()
◆ solveSystem()
- Examples
- wave_equation.cpp.
Definition at line 272 of file wave_equation.cpp.
278 auto create_post_process_element = [&]() {
279 auto post_proc_fe = boost::make_shared<PostProcEle>(
mField);
281 auto det_ptr = boost::make_shared<VectorDouble>();
282 auto jac_ptr = boost::make_shared<MatrixDouble>();
283 auto inv_jac_ptr = boost::make_shared<MatrixDouble>();
285 post_proc_fe->getOpPtrVector().push_back(
287 post_proc_fe->getOpPtrVector().push_back(
290 auto u_ptr = boost::make_shared<VectorDouble>();
291 post_proc_fe->getOpPtrVector().push_back(
296 post_proc_fe->getOpPtrVector().push_back(
298 new OpPPMap(post_proc_fe->getPostProcMesh(),
299 post_proc_fe->getMapGaussPts(),
312 auto set_time_monitor = [&](
auto dm,
auto solver) {
314 boost::shared_ptr<Monitor> monitor_ptr(
315 new Monitor(dm, create_post_process_element()));
316 boost::shared_ptr<ForcesAndSourcesCore>
null;
318 monitor_ptr,
null,
null);
322 auto set_fieldsplit_preconditioner = [&](
auto solver) {
325 CHKERR TSGetSNES(solver, &snes);
327 CHKERR SNESGetKSP(snes, &ksp);
329 CHKERR KSPGetPC(ksp, &pc);
330 PetscBool is_pcfs = PETSC_FALSE;
331 PetscObjectTypeCompare((PetscObject)pc, PCFIELDSPLIT, &is_pcfs);
333 if (is_pcfs == PETSC_TRUE) {
335 auto name_prb =
simple->getProblemName();
336 auto is_all_bc = bc_mng->getBlockIS(name_prb,
"ESSENTIAL",
"U", 0, 0);
338 CHKERR ISGetSize(is_all_bc, &is_all_bc_size);
340 <<
"Field split block size " << is_all_bc_size;
341 CHKERR PCFieldSplitSetIS(pc, PETSC_NULL,
347 auto dm =
simple->getDM();
351 auto ts = pipeline_mng->createTSIM2();
355 CHKERR TS2SetSolution(ts,
D, DD);
356 CHKERR set_time_monitor(dm, ts);
357 CHKERR TSSetFromOptions(ts);
358 CHKERR set_fieldsplit_preconditioner(ts);
362 CHKERR VecGhostUpdateBegin(
D, INSERT_VALUES, SCATTER_FORWARD);
363 CHKERR VecGhostUpdateEnd(
D, INSERT_VALUES, SCATTER_FORWARD);
◆ boundaryMarker
boost::shared_ptr<std::vector<unsigned char> > WaveEquation::boundaryMarker |
|
private |
◆ mField
The documentation for this struct was generated from the following file:
#define MoFEMFunctionReturnHot(a)
Last executable line of each PETSc function used for error handling. Replaces return()
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.
MoFEMErrorCode initialCondition()
MoFEMErrorCode setupProblem()
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpBaseTimesScalar< 1 > OpDomainTimesScalarField
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpGradTimesTensor< 1, 1, SPACE_DIM > OpDomainGradTimesVec
FormsIntegrators< BoundaryEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpSource< 1, 1 > OpBoundarySource
PipelineManager interface.
PetscErrorCode DMoFEMMeshToLocalVector(DM dm, Vec l, InsertMode mode, ScatterMode scatter_mode)
set local (or ghosted) vector values on mesh for partition only
boost::shared_ptr< FEMethod > & getBoundaryRhsFE()
MoFEM::Interface & mField
Simple interface for fast problem set-up.
FormsIntegrators< BoundaryEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpMass< 1, 1 > OpBoundaryMass
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpMass< 1, 1 > OpDomainMass
Get field gradients at integration pts for scalar filed rank 0, i.e. vector field.
MoFEMErrorCode boundaryCondition()
MoFEMErrorCode setIntegrationRules()
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpGradGrad< 1, 1, SPACE_DIM > OpDomainGradGrad
#define CHKERR
Inline error check.
auto createDMVector(DM dm)
Get smart vector from DM.
Simple interface for fast problem set-up.
void simple(double P1[], double P2[], double P3[], double c[], const int N)
constexpr double wave_speed2
OpPostProcMapInMoab< SPACE_DIM, SPACE_DIM > OpPPMap
MoFEMErrorCode solveSystem()
Get value at integration points for scalar field.
MoFEMErrorCode readMesh()
MoFEMErrorCode outputResults()
Modify integration weights on face to take in account higher-order geometry.
constexpr double t
plate stiffness
FTensor::Index< 'i', SPACE_DIM > i
OpCalculateScalarFieldValuesFromPetscVecImpl< PetscData::CTX_SET_X_TT > OpCalculateScalarFieldValuesDotDot
boost::shared_ptr< FEMethod > & getDomainLhsFE()
#define MOFEM_LOG(channel, severity)
Log.
SmartPetscObj< Vec > vectorDuplicate(Vec vec)
Create duplicate vector of smart vector.
[Push operators to pipeline]
PetscErrorCode DMMoFEMTSSetMonitor(DM dm, TS ts, const std::string fe_name, boost::shared_ptr< MoFEM::FEMethod > method, boost::shared_ptr< MoFEM::BasicMethod > pre_only, boost::shared_ptr< MoFEM::BasicMethod > post_only)
Set Monitor To TS solver.
@ AINSWORTH_LEGENDRE_BASE
Ainsworth Cole (Legendre) approx. base .
Set indices on entities on finite element.
boost::shared_ptr< std::vector< unsigned char > > boundaryMarker
const double D
diffusivity
#define MoFEMFunctionBeginHot
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
FormsIntegrators< BoundaryEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpBaseTimesScalar< 1 > OpBoundaryTimeScalarField
PetscErrorCode PetscOptionsGetInt(PetscOptions *, const char pre[], const char name[], PetscInt *ivalue, PetscBool *set)
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
MoFEMErrorCode assembleSystem()
Post post-proc data at points from hash maps.