static char help[] = 
"...\n\n";
 
 
 
using EleOp = Ele::UserDataOperator;
 
 
 
    GAUSS>::OpSource<BASE_DIM, SPACE_DIM>;
 
constexpr double a0 = 0.0;
 
constexpr double a1 = 2.0;
 
constexpr double a2 = -15.0 * 
a0;
 
constexpr double a3 = -20.0 / 6 * 
a1;
 
constexpr double a4 = 15.0 * 
a0;
 
constexpr double a5 = 
a1;
 
constexpr double a6 = -
a0;
 
 
                                                double z) {
        
        x + y*y + x*x*x,
        
        y + z*x + y*y*y,
        
        z + x*x + z*z*z);
  }
 
  diffFun(
const double x, 
const double y, 
const double z) {
 
        
        1. + 3 * x * x,
        
        2. * y,
        
        0.,
        
        z,
        
        1. + 3 * y * y,
        
        x,
        
        2 * x, 0., 1. + 3 * z * z);
  }
 
}; 
 
  boost::shared_ptr<MatrixDouble> 
ptrVals;
  boost::shared_ptr<MatrixDouble> 
ptrGrad;
 
                      boost::shared_ptr<MatrixDouble> ptr_grad)
 
 
 
 
    auto t_vals_from_op = getFTensor1FromMat<SPACE_DIM>(*
ptrVals);
 
    auto t_grad_from_op = getFTensor2FromMat<SPACE_DIM, SPACE_DIM>(*
ptrGrad);
 
 
    for (int gg = 0; gg != nb_gauss_pts; gg++) {
 
      
      double err_val = sqrt(delta_val(
i) * delta_val(
i));
 
      MOFEM_LOG(
"SELF", Sev::verbose) << 
"Approximation error: " << err_val;
 
 
                 err_val);
 
 
      double err_diff_val = sqrt(delta_diff_val(
i, 
j) * delta_diff_val(
i, 
j));
 
                 "Wrong derivative of value %4.3e", err_diff_val);
 
      ++t_vals_from_op;
      ++t_grad_from_op;
    }
  }
};
 
int main(
int argc, 
char *argv[]) {
 
 
 
  try {
 
    DMType dm_name = "DMMOFEM";
 
    moab::Core mb_instance;
    moab::Interface &moab = mb_instance;
 
    
 
 
    
    enum bases { AINSWORTH, DEMKOWICZ, LASBASETOP };
    const char *list_bases[] = {"ainsworth", "demkowicz"};
    PetscBool flg;
    PetscInt choice_base_value = AINSWORTH;
                                LASBASETOP, &choice_base_value, &flg);
 
    if (flg != PETSC_TRUE)
    if (choice_base_value == AINSWORTH)
    else if (choice_base_value == DEMKOWICZ)
 
    AinsworthOrderHooks::broken_nbfacetri_edge_hdiv = [](int p) { return p; };
    AinsworthOrderHooks::broken_nbfacetri_face_hdiv = [](int p) { return p; };
    AinsworthOrderHooks::broken_nbvolumetet_edge_hdiv = [](int p) { return p; };
    AinsworthOrderHooks::broken_nbvolumetet_face_hdiv = [](int p) { return p; };
    AinsworthOrderHooks::broken_nbvolumetet_volume_hdiv = [](int p) {
      return p;
    };
 
 
 
    auto assemble_matrices_and_vectors = [&]() {
 
          pipeline_mng->getOpDomainRhsPipeline(), {HDIV});
      pipeline_mng->getOpDomainRhsPipeline().push_back(
 
          pipeline_mng->getOpDomainLhsPipeline(), {HDIV});
      pipeline_mng->getOpDomainLhsPipeline().push_back(
 
                           [](double x, double, double) { return 1; })
 
      );
 
        return 2 * p_data + 1;
      };
 
    };
 
    auto solve_problem = [&] {
      auto solver = pipeline_mng->createKSP();
      CHKERR KSPSetFromOptions(solver);
 
 
 
      CHKERR VecGhostUpdateBegin(
D, INSERT_VALUES, SCATTER_FORWARD);
 
      CHKERR VecGhostUpdateEnd(
D, INSERT_VALUES, SCATTER_FORWARD);
 
    };
 
    auto check_solution = [&] {
 
      pipeline_mng->getOpDomainLhsPipeline().clear();
      pipeline_mng->getOpDomainRhsPipeline().clear();
 
      auto ptr_values = boost::make_shared<MatrixDouble>();
      auto ptr_grad = boost::make_shared<MatrixDouble>();
 
      
          pipeline_mng->getOpDomainRhsPipeline(), {HDIV});
 
      
      pipeline_mng->getOpDomainRhsPipeline().push_back(
      
      pipeline_mng->getOpDomainRhsPipeline().push_back(
                                                                 ptr_grad));
      pipeline_mng->getOpDomainRhsPipeline().push_back(
 
      CHKERR pipeline_mng->loopFiniteElements();
 
 
    };
 
    CHKERR assemble_matrices_and_vectors();
 
  }
 
}
#define FTENSOR_INDEX(DIM, I)
void simple(double P1[], double P2[], double P3[], double c[], const int N)
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::LinearForm< GAUSS >::OpSource< 1, FIELD_DIM > OpDomainSource
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpMass< 1, FIELD_DIM > OpDomainMass
#define CATCH_ERRORS
Catch errors.
FieldApproximationBase
approximation base
@ AINSWORTH_LEGENDRE_BASE
Ainsworth Cole (Legendre) approx. base .
@ HDIV
field with continuous normal traction
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
@ MOFEM_ATOM_TEST_INVALID
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
#define CHKERR
Inline error check.
PetscErrorCode DMoFEMMeshToLocalVector(DM dm, Vec l, InsertMode mode, ScatterMode scatter_mode)
set local (or ghosted) vector values on mesh for partition only
PetscErrorCode DMRegister_MoFEM(const char sname[])
Register MoFEM problem.
auto createDMVector(DM dm)
Get smart vector from DM.
#define MOFEM_LOG(channel, severity)
Log.
MoFEM::PipelineManager::ElementsAndOpsByDim< SPACE_DIM >::DomainEle Ele
PetscErrorCode MoFEMErrorCode
MoFEM/PETSc error code.
UBlasMatrix< double > MatrixDouble
implementation of Data Operators for Forces and Sources
SmartPetscObj< Vec > vectorDuplicate(Vec vec)
Create duplicate vector of smart vector.
PetscErrorCode PetscOptionsGetEList(PetscOptions *, const char pre[], const char name[], const char *const *list, PetscInt next, PetscInt *value, PetscBool *set)
FormsIntegrators< DomainEleOp >::Assembly< PETSC >::BiLinearForm< GAUSS >::OpMass< 1, SPACE_DIM > OpMass
[Only used with Hooke equation (linear material model)]
static FTensor::Tensor2< double, BASE_DIM, SPACE_DIM > diffFun(const double x, const double y)
static FTensor::Tensor1< double, BASE_DIM > fUn(const double x, const double y, double z)
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)
MatrixDouble & getCoordsAtGaussPts()
Gauss points and weight, matrix (nb. of points x 3)
@ OPSPACE
operator do Work is execute on space data
MatrixDouble & getGaussPts()
matrix of integration (Gauss) points for Volume Element
Get vector field for H-div approximation.
Calculate gradient of vector field.
Template struct for dimension-specific finite element types.
PipelineManager interface.
Simple interface for fast problem set-up.
MoFEMErrorCode getInterface(IFACE *&iface) const
Get interface reference to pointer of interface.
FTensor::Index< 'i', 3 > i
boost::shared_ptr< MatrixDouble > ptrVals
MoFEMErrorCode doWork(int side, EntityType type, EntitiesFieldData::EntData &data)
Operator for linear form, usually to calculate values on right hand side.
FTensor::Index< 'j', 2 > j
boost::shared_ptr< MatrixDouble > ptrGrad
FTensor::Index< 'k', 2 > k