? AssemblyType::BLOCK_SCHUR
 
    IntegrationType::GAUSS; 
 
 
 
 
 
};
 
};
 
 
 
 
 
protected:
};
 
}
 
  static boost::shared_ptr<SetUpSchur>
 
protected:
};
 
static char help[] = 
"...\n\n";
 
 
int main(
int argc, 
char *argv[]) {
 
 
  
  const char param_file[] = "param_file.petsc";
 
  auto core_log = logging::core::get();
  core_log->add_sink(
      LogManager::createSink(LogManager::getStrmWorld(), "TIMER"));
 
  core_log->add_sink(
      LogManager::createSink(LogManager::getStrmSync(), "FieldEvaluator"));
  LogManager::setLog("FieldEvaluator");
 
  try {
 
    DMType dm_name = "DMMOFEM";
    DMType dm_name_mg = "DMMOFEM_MG";
 
    moab::Core mb_instance;              
    moab::Interface &moab = mb_instance; 
 
 
  }
 
}
 
 
 
  if (
A == AssemblyType::BLOCK_SCHUR || 
A == AssemblyType::SCHUR) {
 
    CHKERR schur_ptr->setUp(solver);
 
  }
 
 
  BOOST_LOG_SCOPED_THREAD_ATTR("Timeline", attrs::timer());
  MOFEM_LOG(
"TIMER", Sev::inform) << 
"KSPSetUp";
 
  MOFEM_LOG(
"TIMER", Sev::inform) << 
"KSPSetUp <= Done";
 
 
  DM dm;
 
  MOFEM_LOG(
"TIMER", Sev::inform) << 
"KSPSolve";
 
  MOFEM_LOG(
"TIMER", Sev::inform) << 
"KSPSolve <= Done";
 
 
  CHKERR VecGhostUpdateBegin(
D, INSERT_VALUES, SCATTER_FORWARD);
 
  CHKERR VecGhostUpdateEnd(
D, INSERT_VALUES, SCATTER_FORWARD);
 
 
};
 
 
          "Is expected that schur matrix is not allocated. This is "
          "possible only is PC is set up twice");
    }
  }
 
 
private:
 
 
 
};
 
  PC pc;
  PetscBool is_pcfs = PETSC_FALSE;
  PetscObjectTypeCompare((PetscObject)pc, PCFIELDSPLIT, &is_pcfs);
  if (is_pcfs) {
          "Is expected that schur matrix is not allocated. This is "
          "possible only is PC is set up twice");
    }
 
    
    CHKERR MatSetOption(
S, MAT_SYMMETRIC, PETSC_TRUE);
 
 
 
    if constexpr (
A == AssemblyType::BLOCK_SCHUR) {
 
      
      DM solver_dm;
      CHKERR KSPGetDM(solver, &solver_dm);
 
      CHKERR DMSetMatType(solver_dm, MATSHELL);
 
    }
 
  } else {
  }
}
 
};
 
 
  auto create_dm = [&](const char *name, auto &ents, auto dm_type) {
    auto create_dm_imp = [&]() {
      auto sub_ents_ptr = boost::make_shared<Range>(ents);
    };
        create_dm_imp(),
        "Error in creating schurDM. It is possible that schurDM is "
        "already created");
    return dm;
  };
 
 
  if constexpr (
A == AssemblyType::BLOCK_SCHUR) {
 
 
    auto get_nested_mat_data = [&]() -> boost::shared_ptr<NestSchurData> {
      auto block_mat_data =
 
                                  {{
 
                                      simple->getDomainFEName(),
 
                                      {{"U", "U"}
 
                                      }}}
 
          );
 
 
 
          {
"U"}, {boost::make_shared<Range>(
volEnts)}
 
      );
    };
 
    auto nested_mat_data = get_nested_mat_data();
 
  }
 
}
 
 
  
      {
"U"}, {boost::make_shared<Range>(
volEnts)}, ao_up, 
S, 
true, 
true));
  
      {
"U"}, {boost::make_shared<Range>(
volEnts)}, ao_up, 
S, 
true, 
true));
 
  auto pre_proc_schur_lhs_ptr = boost::make_shared<FEMethod>();
  auto post_proc_schur_lhs_ptr = boost::make_shared<FEMethod>();
 
  pre_proc_schur_lhs_ptr->preProcessHook = [this]() {
    }
    MOFEM_LOG(
"TIMER", Sev::inform) << 
"Lhs Assemble Begin";
 
  };
 
  post_proc_schur_lhs_ptr->postProcessHook = [this, post_proc_schur_lhs_ptr,
                                              ao_up]() {
    CHKERR MatAssemblyBegin(
S, MAT_FINAL_ASSEMBLY);
 
    CHKERR MatAssemblyEnd(
S, MAT_FINAL_ASSEMBLY);
 
        mField, post_proc_schur_lhs_ptr, 1, 
S, ao_up)();
 
    MOFEM_LOG(
"TIMER", Sev::inform) << 
"Lhs Assemble End";
 
  };
 
  ksp_ctx_ptr->getPreProcSetOperators().push_front(pre_proc_schur_lhs_ptr);
  ksp_ctx_ptr->getPostProcSetOperators().push_back(post_proc_schur_lhs_ptr);
 
}
 
  CHKERR PCFieldSplitSetIS(pc, NULL, vol_is);
 
  CHKERR PCFieldSplitSetSchurPre(pc, PC_FIELDSPLIT_SCHUR_PRE_USER, 
S);
 
}
 
 
  auto get_pc = [](auto ksp) {
    PC pc_raw;
    CHKERR KSPGetPC(ksp, &pc_raw);
 
  };
 
  if constexpr (
A == AssemblyType::BLOCK_SCHUR) {
 
 
    KSP *subksp;
    CHKERR PCFieldSplitSchurGetSubKSP(pc, PETSC_NULLPTR, &subksp);
 
 
    auto set_pc_p_mg = [](
auto dm, 
auto pc, 
auto S) {
 
      PetscBool same = PETSC_FALSE;
      PetscObjectTypeCompare((PetscObject)pc, PCMG, &same);
      if (same) {
        MOFEM_LOG(
"TIMER", Sev::inform) << 
"Set up MG";
 
      }
    };
 
    auto set_pc_ksp = [&](
auto dm, 
auto pc, 
auto S) {
 
      PetscBool same = PETSC_FALSE;
      PetscObjectTypeCompare((PetscObject)pc, PCKSP, &same);
      if (same) {
        MOFEM_LOG(
"TIMER", Sev::inform) << 
"Set up inner KSP for PCKSP";
 
        KSP inner_ksp;
        CHKERR PCKSPGetKSP(pc, &inner_ksp);
 
        CHKERR KSPSetFromOptions(inner_ksp);
 
        PC inner_pc;
        CHKERR KSPGetPC(inner_ksp, &inner_pc);
 
        CHKERR PCSetFromOptions(inner_pc);
 
        CHKERR set_pc_p_mg(dm, inner_pc, 
S);
 
      }
    };
 
 
  }
}
 
boost::shared_ptr<SetUpSchur>
}
Implementation of elastic example class.
void simple(double P1[], double P2[], double P3[], double c[], const int N)
ElementsAndOps< SPACE_DIM >::DomainEle DomainEle
ElementsAndOps< SPACE_DIM >::BoundaryEle BoundaryEle
#define CATCH_ERRORS
Catch errors.
#define CHK_THROW_MESSAGE(err, msg)
Check and throw MoFEM exception.
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
@ MOFEM_DATA_INCONSISTENCY
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
#define CHKERR
Inline error check.
PostProcEleByDim< SPACE_DIM >::PostProcEleDomain PostProcEleDomain
PostProcEleByDim< SPACE_DIM >::PostProcEleBdy PostProcEleBdy
PetscErrorCode DMMoFEMCreateSubDM(DM subdm, DM dm, const char problem_name[])
Must be called by user to set Sub DM MoFEM data structures.
PetscErrorCode DMMoFEMAddElement(DM dm, std::string fe_name)
add element to dm
PetscErrorCode DMMoFEMSetSquareProblem(DM dm, PetscBool square_problem)
set squared problem
PetscErrorCode DMoFEMMeshToLocalVector(DM dm, Vec l, InsertMode mode, ScatterMode scatter_mode)
set local (or ghosted) vector values on mesh for partition only
PetscErrorCode DMMoFEMAddSubFieldRow(DM dm, const char field_name[])
PetscErrorCode DMRegister_MoFEM(const char sname[])
Register MoFEM problem.
MoFEMErrorCode DMRegister_MGViaApproxOrders(const char sname[])
Register DM for Multi-Grid via approximation orders.
auto createDMVector(DM dm)
Get smart vector from DM.
PetscErrorCode DMMoFEMAddSubFieldCol(DM dm, const char field_name[])
auto createDMMatrix(DM dm)
Get smart matrix from DM.
#define MOFEM_LOG(channel, severity)
Log.
#define MOFEM_LOG_TAG(channel, tag)
Tag channel.
#define MOFEM_LOG_CHANNEL(channel)
Set and reset channel.
PetscErrorCode MoFEMErrorCode
MoFEM/PETSc error code.
implementation of Data Operators for Forces and Sources
OpSchurAssembleBase * createOpSchurAssembleEnd(std::vector< std::string > fields_name, std::vector< boost::shared_ptr< Range > > field_ents, SmartPetscObj< AO > ao, SmartPetscObj< Mat > schur, bool sym_schur, bool symm_op)
Construct a new Op Schur Assemble End object.
MoFEMErrorCode setSchurA00MatSolvePC(SmartPetscObj< PC > pc)
Set PC for A00 block.
SmartPetscObj< Vec > vectorDuplicate(Vec vec)
Create duplicate vector of smart vector.
boost::shared_ptr< PCMGSetUpViaApproxOrdersCtx > createPCMGSetUpViaApproxOrdersCtx(DM dm, Mat A, bool use_shell_mat)
createPCMGSetUpViaApproxOrdersCtx
auto getDMKspCtx(DM dm)
Get KSP context data structure used by DM.
auto getDMSubData(DM dm)
Get sub problem data structure.
MoFEMErrorCode PCMGSetUpViaApproxOrders(PC pc, boost::shared_ptr< PCMGSetUpViaApproxOrdersCtx > ctx, int verb)
Function build MG structure.
boost::shared_ptr< BlockStructure > createBlockMatStructure(DM dm, SchurFEOpsFEandFields schur_fe_op_vec)
Create a Mat Diag Blocks object.
boost::shared_ptr< NestSchurData > createSchurNestedMatrixStruture(std::pair< SmartPetscObj< DM >, SmartPetscObj< DM > > dms, boost::shared_ptr< BlockStructure > block_mat_data_ptr, std::vector< std::string > fields_names, std::vector< boost::shared_ptr< Range > > field_ents, bool add_preconditioner_block)
Get the Schur Nest Mat Array object.
auto createAOMappingIS(IS isapp, IS ispetsc)
Creates an application mapping using two index sets.
MoFEMErrorCode DMMoFEMSetNestSchurData(DM dm, boost::shared_ptr< NestSchurData >)
auto createDMNestSchurMat(DM dm)
auto createDM(MPI_Comm comm, const std::string dm_type_name)
Creates smart DM object.
OpSchurAssembleBase * createOpSchurAssembleBegin()
auto createDMBlockMat(DM dm)
constexpr IntegrationType I
NaturalBC< BoundaryEleOp >::Assembly< AT >::BiLinearForm< IT > BoundaryLhsBCs
NaturalBC< BoundaryEleOp >::Assembly< AT >::LinearForm< IT > BoundaryRhsBCs
#define EXECUTABLE_DIMENSION
BoundaryLhsBCs::OpFlux< PlasticOps::BoundaryBCs, 1, SPACE_DIM > OpBoundaryLhsBCs
NaturalBC< DomainEleOp >::Assembly< AT >::LinearForm< IT > DomainRhsBCs
DomainRhsBCs::OpFlux< PlasticOps::DomainBCs, 1, SPACE_DIM > OpDomainRhsBCs
BoundaryRhsBCs::OpFlux< PlasticOps::BoundaryBCs, 1, SPACE_DIM > OpBoundaryRhsBCs
ElementsAndOps< SPACE_DIM >::SideEle SideEle
constexpr AssemblyType A
[Define dimension]
Boundary conditions marker.
MoFEMErrorCode solveSystem()
[Solve]
MoFEMErrorCode outputResults()
[Solve]
MoFEMErrorCode assembleSystem()
[Boundary condition]
MoFEMErrorCode setupProblem()
[Read mesh]
MoFEM::Interface & mField
MoFEMErrorCode boundaryCondition()
[Set up problem]
MoFEMErrorCode checkResults()
[Postprocess results]
MoFEMErrorCode readMesh()
[Run problem]
MoFEMErrorCode kspSetUpAndSolve(SmartPetscObj< KSP > solver)
[Push operators to pipeline]
MoFEMErrorCode runProblem()
[Run problem]
virtual moab::Interface & get_moab()=0
virtual MPI_Comm & get_comm() const =0
static MoFEMErrorCode Initialize(int *argc, char ***args, const char file[], const char help[])
Initializes the MoFEM database PETSc, MOAB and MPI.
static MoFEMErrorCode Finalize()
Checks for options to be called at the conclusion of the program.
Deprecated interface functions.
Data on single entity (This is passed as argument to DataOperator::doWork)
Class (Function) to enforce essential constrains on the left hand side diagonal.
Section manager is used to create indexes and sections.
Template struct for dimension-specific finite element types.
PipelineManager interface.
Simple interface for fast problem set-up.
intrusive_ptr for managing petsc objects
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.
virtual ~SetUpSchurImpl()=default
MoFEMErrorCode createSubDM()
MoFEMErrorCode setDiagonalPC(PC pc)
SmartPetscObj< DM > schurDM
MoFEMErrorCode setEntities()
MoFEMErrorCode setUp(SmartPetscObj< KSP >)
SmartPetscObj< DM > blockDM
MoFEMErrorCode setPC(PC pc)
MoFEMErrorCode setOperator()
MoFEM::Interface & mField
[Push operators to pipeline]
virtual MoFEMErrorCode setUp(SmartPetscObj< KSP >)=0
static boost::shared_ptr< SetUpSchur > createSetUpSchur(MoFEM::Interface &m_field)