13 #ifndef EXECUTABLE_DIMENSION
14 #define EXECUTABLE_DIMENSION 3
17 #ifndef SCHUR_ASSEMBLE
18 #define SCHUR_ASSEMBLE 0
24 using namespace MoFEM;
26 #include <GenericElementInterface.hpp>
29 #include <boost/python.hpp>
30 #include <boost/python/def.hpp>
31 #include <boost/python/numpy.hpp>
32 namespace bp = boost::python;
33 namespace np = boost::python::numpy;
75 IT>::OpBaseTimesVector<1, SPACE_DIM, 1>;
109 #ifdef WITH_MODULE_MFRONT_INTERFACE
110 #include <MFrontMoFEMInterface.hpp>
149 boost::shared_ptr<SDFPython> sdfPythonPtr;
164 CHKERR createCommonData();
193 enum bases { AINSWORTH, DEMKOWICZ, LASBASETOPT };
194 const char *list_bases[LASBASETOPT] = {
"ainsworth",
"demkowicz"};
195 PetscInt choice_base_value = AINSWORTH;
197 LASBASETOPT, &choice_base_value, PETSC_NULL);
200 switch (choice_base_value) {
204 <<
"Set AINSWORTH_LEGENDRE_BASE for displacements";
209 <<
"Set DEMKOWICZ_JACOBI_BASE for displacements";
231 CHKERR mField.get_moab().get_entities_by_dimension(0,
SPACE_DIM, body_ents);
232 Skinner skin(&mField.get_moab());
234 CHKERR skin.find_skin(0, body_ents,
false, skin_ents);
238 auto filter_blocks = [&](
auto skin) {
239 bool is_contact_block =
false;
244 (boost::format(
"%s(.*)") %
"CONTACT").str()
253 <<
"Find contact block set: " <<
m->getName();
254 auto meshset =
m->getMeshset();
255 Range contact_meshset_range;
256 CHKERR mField.get_moab().get_entities_by_dimension(
257 meshset,
SPACE_DIM - 1, contact_meshset_range,
true);
260 contact_meshset_range);
261 contact_range.merge(contact_meshset_range);
263 if (is_contact_block) {
265 <<
"Nb entities in contact surface: " << contact_range.size();
267 skin = intersect(skin, contact_range);
274 ParallelComm *pcomm =
276 CHKERR pcomm->filter_pstatus(skin, PSTATUS_SHARED | PSTATUS_MULTISHARED,
277 PSTATUS_NOT, -1, &boundary_ents);
278 return boundary_ents;
288 CHKERR mField.get_moab().get_adjacencies(boundary_ents, 1,
false, ho_ents,
289 moab::Interface::UNION);
298 auto project_ho_geometry = [&]() {
300 return mField.loop_dofs(
"GEOMETRY", ent_method);
303 PetscBool project_geometry = PETSC_TRUE;
305 &project_geometry, PETSC_NULL);
306 if (project_geometry) {
307 CHKERR project_ho_geometry();
317 PetscBool use_mfront = PETSC_FALSE;
339 if (!mfrontInterface) {
343 MOFEM_LOG(
"CONTACT", Sev::inform) <<
"Using MFront for material model";
354 PetscBool use_scale = PETSC_FALSE;
369 char sdf_file_name[255];
371 sdf_file_name, 255, PETSC_NULL);
373 sdfPythonPtr = boost::make_shared<SDFPython>();
374 CHKERR sdfPythonPtr->sdfInit(sdf_file_name);
375 sdfPythonWeakPtr = sdfPythonPtr;
381 "Use executable contact_2d with axisymmetric model");
385 "Axisymmetric model is only available with MFront (set "
388 MOFEM_LOG(
"CONTACT", Sev::inform) <<
"Using axisymmetric model";
393 MOFEM_LOG(
"CONTACT", Sev::inform) <<
"Using plane strain model";
398 #ifndef WITH_MODULE_MFRONT_INTERFACE
401 "MFrontInterface module was not found while use_mfront was set to 1");
405 boost::make_shared<MFrontMoFEMInterface<TRIDIMENSIONAL>>(
410 boost::make_shared<MFrontMoFEMInterface<AXISYMMETRICAL>>(
413 mfrontInterface = boost::make_shared<MFrontMoFEMInterface<PLANESTRAIN>>(
418 CHKERR mfrontInterface->getCommandLineParameters();
422 auto dm =
simple->getDM();
427 mfrontInterface->setMonitorPtr(monitorPtr);
437 auto bc_mng = mField.getInterface<
BcManager>();
440 for (
auto f : {
"U",
"SIGMA"}) {
441 CHKERR bc_mng->removeBlockDOFsOnEntities(
simple->getProblemName(),
442 "REMOVE_X",
f, 0, 0);
443 CHKERR bc_mng->removeBlockDOFsOnEntities(
simple->getProblemName(),
444 "REMOVE_Y",
f, 1, 1);
445 CHKERR bc_mng->removeBlockDOFsOnEntities(
simple->getProblemName(),
446 "REMOVE_Z",
f, 2, 2);
447 CHKERR bc_mng->removeBlockDOFsOnEntities(
simple->getProblemName(),
448 "REMOVE_ALL",
f, 0, 3);
451 CHKERR bc_mng->removeBlockDOFsOnEntities(
simple->getProblemName(),
"FIX_X",
452 "SIGMA", 0, 0,
false,
true);
453 CHKERR bc_mng->removeBlockDOFsOnEntities(
simple->getProblemName(),
"FIX_Y",
454 "SIGMA", 1, 1,
false,
true);
455 CHKERR bc_mng->removeBlockDOFsOnEntities(
simple->getProblemName(),
"FIX_Z",
456 "SIGMA", 2, 2,
false,
true);
457 CHKERR bc_mng->removeBlockDOFsOnEntities(
simple->getProblemName(),
"FIX_ALL",
458 "SIGMA", 0, 3,
false,
true);
459 CHKERR bc_mng->removeBlockDOFsOnEntities(
460 simple->getProblemName(),
"NO_CONTACT",
"SIGMA", 0, 3,
false,
true);
465 simple->getProblemName(),
"U");
476 auto time_scale = boost::make_shared<ScaledTimeScale>();
477 auto body_force_time_scale =
478 boost::make_shared<ScaledTimeScale>(
"body_force_hist.txt");
487 auto add_domain_base_ops = [&](
auto &pip) {
494 auto hencky_common_data_ptr = boost::make_shared<HenckyOps::CommonData>();
495 hencky_common_data_ptr->matDPtr = boost::make_shared<MatrixDouble>();
496 hencky_common_data_ptr->matGradPtr = boost::make_shared<MatrixDouble>();
498 auto add_domain_ops_lhs = [&](
auto &pip) {
508 auto fe_domain_lhs = pip_mng->getDomainLhsFE();
510 auto get_inertia_and_mass_damping =
512 return (
rho *
scale) * fe_domain_lhs->ts_aa +
515 pip.push_back(
new OpMass(
"U",
"U", get_inertia_and_mass_damping));
519 auto fe_domain_lhs = pip_mng->getDomainLhsFE();
521 auto get_inertia_and_mass_damping =
525 pip.push_back(
new OpMass(
"U",
"U", get_inertia_and_mass_damping));
528 if (!mfrontInterface) {
529 CHKERR HenckyOps::opFactoryDomainLhs<SPACE_DIM, AT, IT, DomainEleOp>(
530 mField, pip,
"U",
"MAT_ELASTIC", Sev::verbose,
scale);
532 CHKERR mfrontInterface->opFactoryDomainLhs(pip);
538 auto add_domain_ops_rhs = [&](
auto &pip) {
542 pip, mField,
"U", {body_force_time_scale}, Sev::inform);
546 AT>::LinearForm<IT>::OpBaseTimesVector<1,
SPACE_DIM, 1>;
551 auto mat_acceleration = boost::make_shared<MatrixDouble>();
553 "U", mat_acceleration));
555 new OpInertiaForce(
"U", mat_acceleration, [](
double,
double,
double) {
562 auto mat_velocity = boost::make_shared<MatrixDouble>();
566 new OpInertiaForce(
"U", mat_velocity, [](
double,
double,
double) {
571 if (!mfrontInterface) {
572 CHKERR HenckyOps::opFactoryDomainRhs<SPACE_DIM, AT, IT, DomainEleOp>(
573 mField, pip,
"U",
"MAT_ELASTIC", Sev::inform,
scale);
575 CHKERR mfrontInterface->opFactoryDomainRhs(pip);
578 CHKERR ContactOps::opFactoryDomainRhs<SPACE_DIM, AT, IT, DomainEleOp>(
584 auto add_boundary_base_ops = [&](
auto &pip) {
594 auto add_boundary_ops_lhs = [&](
auto &pip) {
604 pip, mField,
"U", Sev::inform);
609 auto fe_boundary_lhs = pip_mng->getBoundaryLhsFE();
614 [
this, fe_boundary_lhs](
double,
double,
double) {
623 ContactOps::opFactoryBoundaryLhs<SPACE_DIM, AT, GAUSS, BoundaryEleOp>(
627 mField, pip,
simple->getDomainFEName(),
"SIGMA",
"U",
"GEOMETRY",
633 auto add_boundary_ops_rhs = [&](
auto &pip) {
638 AT>::LinearForm<IT>::OpBaseTimesVector<1,
SPACE_DIM, 1>;
643 pip, mField,
"U", {time_scale}, Sev::inform);
646 auto u_disp = boost::make_shared<MatrixDouble>();
647 auto dot_u_disp = boost::make_shared<MatrixDouble>();
652 new OpSpringRhs(
"U", u_disp, [
this](
double,
double,
double) {
656 new OpSpringRhs(
"U", dot_u_disp, [
this](
double,
double,
double) {
662 ContactOps::opFactoryBoundaryRhs<SPACE_DIM, AT, GAUSS, BoundaryEleOp>(
668 CHKERR add_domain_base_ops(pip_mng->getOpDomainLhsPipeline());
669 CHKERR add_domain_base_ops(pip_mng->getOpDomainRhsPipeline());
670 CHKERR add_domain_ops_lhs(pip_mng->getOpDomainLhsPipeline());
671 CHKERR add_domain_ops_rhs(pip_mng->getOpDomainRhsPipeline());
673 CHKERR add_boundary_base_ops(pip_mng->getOpBoundaryLhsPipeline());
674 CHKERR add_boundary_base_ops(pip_mng->getOpBoundaryRhsPipeline());
675 CHKERR add_boundary_ops_lhs(pip_mng->getOpBoundaryLhsPipeline());
676 CHKERR add_boundary_ops_rhs(pip_mng->getOpBoundaryRhsPipeline());
678 if (mfrontInterface) {
679 CHKERR mfrontInterface->setUpdateElementVariablesOperators();
682 CHKERR pip_mng->setDomainRhsIntegrationRule(integration_rule_vol);
683 CHKERR pip_mng->setDomainLhsIntegrationRule(integration_rule_vol);
684 CHKERR pip_mng->setBoundaryRhsIntegrationRule(integration_rule_boundary);
685 CHKERR pip_mng->setBoundaryLhsIntegrationRule(integration_rule_boundary);
693 static boost::shared_ptr<SetUpSchur>
708 auto set_section_monitor = [&](
auto solver) {
711 CHKERR TSGetSNES(solver, &snes);
712 PetscViewerAndFormat *vf;
713 CHKERR PetscViewerAndFormatCreate(PETSC_VIEWER_STDOUT_WORLD,
714 PETSC_VIEWER_DEFAULT, &vf);
717 (
MoFEMErrorCode(*)(SNES, PetscInt, PetscReal,
void *))SNESMonitorFields,
722 auto scatter_create = [&](
auto D,
auto coeff) {
724 CHKERR is_manager->isCreateProblemFieldAndRank(
simple->getProblemName(),
725 ROW,
"U", coeff, coeff, is);
727 CHKERR ISGetLocalSize(is, &loc_size);
729 CHKERR VecCreateMPI(mField.get_comm(), loc_size, PETSC_DETERMINE, &
v);
731 CHKERR VecScatterCreate(
D, is,
v, PETSC_NULL, &scatter);
736 auto set_time_monitor = [&](
auto dm,
auto solver) {
738 monitorPtr->setScatterVectors(uXScatter, uYScatter, uZScatter);
739 boost::shared_ptr<ForcesAndSourcesCore>
null;
741 monitorPtr,
null,
null);
745 auto set_essential_bc = [&]() {
749 auto pre_proc_ptr = boost::make_shared<FEMethod>();
750 auto post_proc_rhs_ptr = boost::make_shared<FEMethod>();
751 auto post_proc_lhs_ptr = boost::make_shared<FEMethod>();
754 auto time_scale = boost::make_shared<TimeScale>();
756 auto get_bc_hook_rhs = [&]() {
758 {time_scale},
false);
761 pre_proc_ptr->preProcessHook = get_bc_hook_rhs();
763 auto get_post_proc_hook_rhs = [&]() {
765 mField, post_proc_rhs_ptr, 1.);
767 auto get_post_proc_hook_lhs = [&]() {
769 mField, post_proc_lhs_ptr, 1.);
771 post_proc_rhs_ptr->postProcessHook = get_post_proc_hook_rhs();
773 ts_ctx_ptr->getPreProcessIFunction().push_front(pre_proc_ptr);
774 ts_ctx_ptr->getPreProcessIJacobian().push_front(pre_proc_ptr);
775 ts_ctx_ptr->getPostProcessIFunction().push_back(post_proc_rhs_ptr);
776 post_proc_lhs_ptr->postProcessHook = get_post_proc_hook_lhs();
777 ts_ctx_ptr->getPostProcessIJacobian().push_back(post_proc_lhs_ptr);
782 auto set_schur_pc = [&](
auto solver) {
783 boost::shared_ptr<SetUpSchur> schur_ptr;
792 auto dm =
simple->getDM();
797 uXScatter = scatter_create(
D, 0);
798 uYScatter = scatter_create(
D, 1);
800 uZScatter = scatter_create(
D, 2);
804 CHKERR set_essential_bc();
807 auto solver = pip_mng->createTSIM();
808 CHKERR TSSetFromOptions(solver);
809 auto schur_pc_ptr = set_schur_pc(solver);
812 CHKERR set_section_monitor(solver);
813 CHKERR set_time_monitor(dm, solver);
814 CHKERR TSSetSolution(solver,
D);
816 CHKERR TSSolve(solver, NULL);
818 auto solver = pip_mng->createTSIM2();
819 CHKERR TSSetFromOptions(solver);
820 auto schur_pc_ptr = set_schur_pc(solver);
822 auto dm =
simple->getDM();
826 CHKERR set_section_monitor(solver);
827 CHKERR set_time_monitor(dm, solver);
828 CHKERR TS2SetSolution(solver,
D, DD);
830 CHKERR TSSolve(solver, NULL);
840 if (
atom_test && !mField.get_comm_rank()) {
845 double analytical_active_area = 1.0;
847 double tol_force = 1e-3;
848 double tol_norm = 7.5;
849 double tol_area = 3e-2;
850 double fem_active_area = t_ptr[3];
855 fem_force = t_ptr[1];
860 fem_force = t_ptr[1];
861 norm = monitorPtr->getErrorNorm(1);
867 fem_force = t_ptr[2];
868 analytical_active_area = M_PI / 4;
878 hertz_force = 15.873;
880 fem_force = t_ptr[1];
881 norm = monitorPtr->getErrorNorm(1);
882 analytical_active_area = M_PI;
887 fem_force = t_ptr[1];
891 hertz_force = 0.5289;
892 fem_force = t_ptr[2];
897 "atom test %d does not exist",
atom_test);
899 if (fabs(fem_force - hertz_force) / hertz_force > tol_force) {
901 "atom test %d failed: Wrong FORCE output: %3.4e != %3.4e",
904 if (norm > tol_norm) {
906 "atom test %d failed: Wrong NORM output: %3.4e > %3.4e",
909 if (fabs(fem_active_area - analytical_active_area) > tol_area) {
911 "atom test %d failed: AREA computed %3.4e but should be %3.4e",
912 atom_test, fem_active_area, analytical_active_area);
923 static char help[] =
"...\n\n";
925 int main(
int argc,
char *argv[]) {
933 const char param_file[] =
"param_file.petsc";
937 auto core_log = logging::core::get();
946 DMType dm_name =
"DMMOFEM";
948 DMType dm_name_mg =
"DMMOFEM_MG";
978 if (Py_FinalizeEx() < 0) {
1013 CHKERR TSGetSNES(solver, &snes);
1015 CHKERR SNESGetKSP(snes, &ksp);
1016 CHKERR KSPSetFromOptions(ksp);
1019 CHKERR KSPGetPC(ksp, &pc);
1021 PetscBool is_pcfs = PETSC_FALSE;
1022 PetscObjectTypeCompare((PetscObject)pc, PCFIELDSPLIT, &is_pcfs);
1025 MOFEM_LOG(
"CONTACT", Sev::inform) <<
"Setup Schur pc";
1030 "It is expected that Schur matrix is not allocated. This is "
1031 "possible only if PC is set up twice");
1043 CHKERR TSGetDM(solver, &solver_dm);
1044 CHKERR DMSetMatType(solver_dm, MATSHELL);
1051 auto swap_assemble = [](TS ts, PetscReal
t,
Vec u,
Vec u_t, PetscReal
a,
1052 Mat
A, Mat B,
void *ctx) {
1055 CHKERR TSSetIJacobian(solver,
A,
P, swap_assemble, ts_ctx_ptr.get());
1057 auto swap_assemble = [](TS ts, PetscReal
t,
Vec u,
Vec u_t,
Vec utt,
1058 PetscReal
a, PetscReal aa, Mat
A, Mat B,
1062 CHKERR TSSetI2Jacobian(solver,
A,
P, swap_assemble, ts_ctx_ptr.get());
1070 CHKERR setDiagonalPC(pc);
1073 MOFEM_LOG(
"CONTACT", Sev::inform) <<
"No Schur PC";
1086 auto create_dm = [&](
const char *name,
const char *
field_name,
auto dm_type) {
1087 auto dm =
createDM(mField.get_comm(), dm_type);
1088 auto create_dm_imp = [&]() {
1100 "Error in creating schurDM. It is possible that schurDM is "
1108 schurDM = create_dm(
"SCHUR",
"U",
"DMMOFEM_MG");
1109 blockDM = create_dm(
"BLOCK",
"SIGMA",
"DMMOFEM");
1113 auto get_nested_mat_data = [&](
auto schur_dm,
auto block_dm) {
1119 simple->getDomainFEName(),
1123 {
"U",
"U"}, {
"SIGMA",
"U"}, {
"U",
"SIGMA"}, {
"SIGMA",
"SIGMA"}
1131 {schur_dm, block_dm}, block_mat_data,
1133 {
"SIGMA"}, {
nullptr}, true
1138 auto nested_mat_data = get_nested_mat_data(schurDM, blockDM);
1143 "Only BLOCK_SCHUR is implemented");
1152 double eps_stab = 1e-4;
1158 using OpMassStab = B::OpMass<3, SPACE_DIM * SPACE_DIM>;
1168 pip->getOpBoundaryLhsPipeline().push_back(
1169 new OpMassStab(
"SIGMA",
"SIGMA",
1170 [eps_stab](
double,
double,
double) {
return eps_stab; }));
1171 pip->getOpBoundaryLhsPipeline().push_back(
1179 pip->getOpDomainLhsPipeline().push_back(
1186 auto pre_proc_schur_lhs_ptr = boost::make_shared<FEMethod>();
1187 auto post_proc_schur_lhs_ptr = boost::make_shared<FEMethod>();
1189 pre_proc_schur_lhs_ptr->preProcessHook = [
this]() {
1191 CHKERR MatZeroEntries(S);
1192 MOFEM_LOG(
"CONTACT", Sev::verbose) <<
"Lhs Assemble Begin";
1196 post_proc_schur_lhs_ptr->postProcessHook = [
this, ao_up,
1197 post_proc_schur_lhs_ptr]() {
1199 MOFEM_LOG(
"CONTACT", Sev::verbose) <<
"Lhs Assemble End";
1200 auto print_mat_norm = [
this](
auto a, std::string prefix) {
1203 CHKERR MatNorm(
a, NORM_FROBENIUS, &nrm);
1204 MOFEM_LOG(
"CONTACT", Sev::noisy) << prefix <<
" norm = " << nrm;
1207 CHKERR MatAssemblyBegin(S, MAT_FINAL_ASSEMBLY);
1208 CHKERR MatAssemblyEnd(S, MAT_FINAL_ASSEMBLY);
1210 mField, post_proc_schur_lhs_ptr, 1, S, ao_up)();
1212 CHKERR print_mat_norm(S,
"S");
1214 MOFEM_LOG(
"CONTACT", Sev::verbose) <<
"Lhs Assemble Finish";
1219 ts_ctx_ptr->getPreProcessIJacobian().push_front(pre_proc_schur_lhs_ptr);
1220 ts_ctx_ptr->getPostProcessIJacobian().push_back(post_proc_schur_lhs_ptr);
1227 auto block_is =
getDMSubData(blockDM)->getSmartRowIs();
1228 CHKERR PCFieldSplitSetIS(pc, NULL, block_is);
1229 CHKERR PCFieldSplitSetSchurPre(pc, PC_FIELDSPLIT_SCHUR_PRE_USER, S);
1236 CHKERR PCFieldSplitSchurGetSubKSP(pc, PETSC_NULL, &subksp);
1237 auto get_pc = [](
auto ksp) {
1239 CHKERR KSPGetPC(ksp, &pc_raw);
1244 auto set_pc_p_mg = [](
auto dm,
auto pc,
auto S) {
1247 PetscBool same = PETSC_FALSE;
1248 PetscObjectTypeCompare((PetscObject)pc, PCMG, &same);
1252 CHKERR PCSetFromOptions(pc);
1257 CHKERR set_pc_p_mg(schurDM, get_pc(subksp[1]), S);
1259 CHKERR PetscFree(subksp);
1263 boost::shared_ptr<SetUpSchur>
1265 return boost::shared_ptr<SetUpSchur>(
new SetUpSchurImpl(m_field));