v0.14.0
ForcesAndSourcesCore.hpp
Go to the documentation of this file.
1 /** \file ForcesAndSourcesCore.hpp
2  \brief Implementation of elements on entities.
3 
4  Those element are inherited by user to implement specific implementation of
5  particular problem.
6 
7 */
8 
9 
10 
11 #ifndef __FORCES_AND_SOURCES_CORE__HPP__
12 #define __FORCES_AND_SOURCES_CORE__HPP__
13 
14 using namespace boost::numeric;
15 
16 namespace MoFEM {
17 
18 /** \brief structure to get information form mofem into EntitiesFieldData
19  * \ingroup mofem_forces_and_sources
20  *
21  */
22 struct ForcesAndSourcesCore : public FEMethod {
23 
25 
27  typedef boost::function<int(int order_row, int order_col, int order_data)>
29 
30  typedef boost::function<MoFEMErrorCode(ForcesAndSourcesCore *fe_raw_ptr,
31  int order_row, int order_col,
32  int order_data)>
34 
35  /**
36  * \brief Hook to get rule
37  *
38  * \todo check preferred format how works with gcc and clang,
39  * see
40  * <http://www.boost.org/doc/libs/1_64_0/doc/html/function/tutorial.html#idp247873024>
41  */
43 
44  /**
45  * @brief Set function to calculate integration rule
46  *
47  */
49 
50  /** \brief Data operator to do calculations at integration points.
51  * \ingroup mofem_forces_and_sources
52 
53  Is inherited and implemented by user to do calculations. It can be used in
54  many different ways but typically is used to integrate matrices (f.e.
55  stiffness matrix) and the right hand vector (f.e. force vector).
56 
57  Note: It is assumed that operator is executed for symmetric problem. That
58  means that is executed for not repeating entities on finite element. For
59  example on triangle we have nodes, 3 edges and one face. Because of symmetry
60  calculations are for: nodes-nodes, nodes-edge0, nodes-edge_1, nodes-edge_2,
61  nodes-face,
62  edges_1-edges_1, edges_1-edge_1, edge_1-edge_2,
63  edge_1-edge_1, edge_1-edge_2,
64  edge_2-edge_2,
65  edge_1-face, edge_1-face, edges_3-face,
66  face - face
67 
68  In case of non symmetric problem in addition calculations of lower off
69  diagonal terms. F.e. edge_1-edge_0, esges_3-edge_0, edge_3-edge_1,
70 
71  In that case class variable UserDataOperator::sYmm = false;
72 
73  NoteL: By default sYmm is set for symmetric problems
74 
75  */
76  struct UserDataOperator;
77 
78  /** \brief Use to push back operator for row operator
79 
80  It can be used to calculate nodal forces or other quantities on the mesh.
81 
82  */
83  boost::ptr_deque<UserDataOperator> &getOpPtrVector() { return opPtrVector; }
84 
85  /**
86  * @brief Get the Entity Polynomial Base object
87  *
88  * @return boost::shared_ptr<BaseFunction>&&
89  */
90  auto &getElementPolynomialBase() { return elementPolynomialBasePtr; }
91 
92  /**
93  * @brief Get the User Polynomial Base object
94  *
95  * @return boost::shared_ptr<BaseFunction>&
96  */
97  auto &getUserPolynomialBase() { return userPolynomialBasePtr; }
98 
99  /**
100  * @brief Matrix of integration points
101  *
102  * Columns is equal to number of integration points, numver of rows
103  * depends on dimension of finite element entity, for example for
104  * tetrahedron rows are x,y,z,weight. Last row is integration weight.
105  *
106  * FIXME: that should be moved to private class data and acessed only by
107  * member function
108  */
110 
111  virtual MoFEMErrorCode preProcess();
112  virtual MoFEMErrorCode operator()();
113  virtual MoFEMErrorCode postProcess();
114 
115 public:
116  /** \brief Get max order of approximation for data fields
117 
118  getMeasure getMaxDataOrder () return maximal order on entities, for
119  all data on the element. So for example if finite element is triangle, and
120  triangle base function have order 4 and on edges base function have order
121  2, this function return 4.
122 
123  If finite element has for example 2 or more approximated fields, for
124  example Pressure (order 3) and displacement field (order 5), this function
125  returns 5.
126 
127  */
128  int getMaxDataOrder() const;
129 
130  /// \brief Get max order of approximation for field in rows
131  int getMaxRowOrder() const;
132 
133  /// \brief Get max order of approximation for field in columns
134  int getMaxColOrder() const;
135 
136  /**
137  * @brief Get the entity data
138  *
139  * @param space
140  * @param type
141  * @param side
142  * @return EntitiesFieldData::EntData&
143  */
144  auto &getEntData(const FieldSpace space, const EntityType type,
145  const int side) {
146  return dataOnElement[space]->dataOnEntities[type][side];
147  }
148 
149  /**
150  * @brief Get data on entities and space
151  *
152  * Entities data are stored by space, by entity type, and entity side.
153  *
154  * @return std::array<boost::shared_ptr<EntitiesFieldData>, LASTSPACE>
155  */
156  auto &getDataOnElementBySpaceArray() { return dataOnElement; }
157 
158  /**
159  * @brief Get derived data on entities and space
160  *
161  * Entities data are stored by space, by entity type, and entity side. Derived
162  * data is used to store data on columns, so it shares information about shape
163  * functions wih rows.
164  *
165  * @return std::array<boost::shared_ptr<EntitiesFieldData>, LASTSPACE>
166  */
167  auto &getDerivedDataOnElementBySpaceArray() { return derivedDataOnElement; }
168 
169 protected:
170  /**
171  * \brief get sense (orientation) of entity
172  * @param type type of entity
173  * @param data entity data
174  * @return error code
175  */
176  MoFEMErrorCode getEntitySense(
177  const EntityType type,
178  boost::ptr_vector<EntitiesFieldData::EntData> &data) const;
179 
180  /**
181  * @brief Get the entity data order
182  *
183  * @param type
184  * @param space
185  * @param data
186  * @return MoFEMErrorCode
187  */
188  MoFEMErrorCode getEntityDataOrder(
189  const EntityType type, const FieldSpace space,
190  boost::ptr_vector<EntitiesFieldData::EntData> &data) const;
191 
192  /**
193  * @brief Get the entity sense (orientation)
194  *
195  * @tparam type
196  * @param data
197  * @return MoFEMErrorCode
198  */
199  template <EntityType type>
201  return getEntitySense(type, data.dataOnEntities[type]);
202  }
203 
204  /**
205  * @brief Get the entity data order for given space
206  *
207  * @tparam type
208  * @param data
209  * @param space
210  * @return MoFEMErrorCode
211  */
212  template <EntityType type>
214  const FieldSpace space) const {
215  return getEntityDataOrder(type, space, data.dataOnEntities[type]);
216  }
217 
218  /** \name Indices */
219 
220  /**@{*/
221 
222  /// \brief get node indices
223  template <typename EXTRACTOR>
225  getNodesIndices(const int bit_number,
226  FieldEntity_vector_view &ents_field, VectorInt &nodes_indices,
227  VectorInt &local_nodes_indices, EXTRACTOR &&extractor) const;
228 
229  /// \brief get row node indices from FENumeredDofEntity_multiIndex
230  MoFEMErrorCode getRowNodesIndices(EntitiesFieldData &data,
231  const int bit_number) const;
232 
233  /// \brief get col node indices from FENumeredDofEntity_multiIndex
234  MoFEMErrorCode getColNodesIndices(EntitiesFieldData &data,
235  const int bit_number) const;
236 
237  template <typename EXTRACTOR>
238  MoFEMErrorCode getEntityIndices(EntitiesFieldData &data, const int bit_number,
239  FieldEntity_vector_view &ents_field,
240  const EntityType type_lo,
241  const EntityType type_hi,
242  EXTRACTOR &&extractor) const;
243 
245  getEntityRowIndices(EntitiesFieldData &data, const int bit_number,
246  const EntityType type_lo = MBVERTEX,
247  const EntityType type_hi = MBPOLYHEDRON) const;
248 
250  getEntityColIndices(EntitiesFieldData &data, const int bit_number,
251  const EntityType type_lo = MBVERTEX,
252  const EntityType type_hi = MBPOLYHEDRON) const;
253 
254  /// \brief get NoField indices
256  getNoFieldIndices(const int bit_number,
257  boost::shared_ptr<FENumeredDofEntity_multiIndex> dofs,
258  VectorInt &nodes_indices) const;
259 
260  /// \brief get col NoField indices
261  MoFEMErrorCode getNoFieldRowIndices(EntitiesFieldData &data,
262  const int bit_number) const;
263 
264  /// \brief get col NoField indices
265  MoFEMErrorCode getNoFieldColIndices(EntitiesFieldData &data,
266  const int bit_number) const;
267 
268  /**@}*/
269 
270  /** \name Data */
271 
272  /**@{*/
273 
274  /** Get bit ref level in entities, and set it to data
275  */
276  MoFEMErrorCode getBitRefLevelOnData();
277 
278  /**
279  * \brief Get field data on nodes
280  */
281  MoFEMErrorCode getNoFieldFieldData(const int bit_number,
282  VectorDouble &ent_field_data,
283  VectorDofs &ent_field_dofs,
284  VectorFieldEntities &ent_field) const;
285 
286  MoFEMErrorCode getNoFieldFieldData(EntitiesFieldData &data,
287  const int bit_number) const;
288 
289  /**
290  * \brief Get data on nodes
291  * @param data Data structure
292  * @param field_name Field name
293  * @return Error code
294  */
295  MoFEMErrorCode getNodesFieldData(EntitiesFieldData &data,
296  const int bit_number) const;
297 
299  getEntityFieldData(EntitiesFieldData &data, const int bit_number,
300  const EntityType type_lo = MBVERTEX,
301  const EntityType type_hi = MBPOLYHEDRON) const;
302 
303  /**@}*/
304 
305  /// \brief Get nodes on faces
306  MoFEMErrorCode getFaceNodes(EntitiesFieldData &data) const;
307 
308  /// \brief Get field approximation space and base on entities
310  getSpacesAndBaseOnEntities(EntitiesFieldData &data) const;
311 
312  /** \name Data form NumeredDofEntity_multiIndex */
313 
314  /**@{*/
315 
316  /// \brief get indices of nodal indices which are declared for problem but
317  /// not this particular element
318  MoFEMErrorCode getProblemNodesIndices(const std::string &field_name,
319  const NumeredDofEntity_multiIndex &dofs,
320  VectorInt &nodes_indices) const;
321 
322  /// \brief get indices by type (generic function) which are declared for
323  /// problem but not this particular element
324  MoFEMErrorCode getProblemTypeIndices(const std::string &field_name,
325  const NumeredDofEntity_multiIndex &dofs,
326  EntityType type, int side_number,
327  VectorInt &indices) const;
328 
329  MoFEMErrorCode getProblemNodesRowIndices(const std::string &field_name,
330  VectorInt &nodes_indices) const;
331  MoFEMErrorCode getProblemTypeRowIndices(const std::string &field_name,
332  EntityType type, int side_number,
333  VectorInt &indices) const;
334  MoFEMErrorCode getProblemNodesColIndices(const std::string &field_name,
335  VectorInt &nodes_indices) const;
336  MoFEMErrorCode getProblemTypeColIndices(const std::string &field_name,
337  EntityType type, int side_number,
338  VectorInt &indices) const;
339 
340  /**@}*/
341 
342  /**
343  * \brief another variant of getRule
344  * @param order_row order of base function on row
345  * @param order_col order of base function on columns
346  * @param order_data order of base function approximating data
347  * @return integration rule
348  *
349  * This function is overloaded by the user. The integration rule
350  * is set such that specific operator implemented by the user is
351  * integrated accurately. For example if user implement bilinear operator
352  * \f[
353  * b(u,v) =
354  * \int_\mathcal{T}
355  * \frac{\partial u_i}{\partial x_j}\frac{\partial v_i}{\partial x_j}
356  * \textrm{d}\mathcal{T}
357  * \f]
358  * then if \f$u\f$ and \f$v\f$ are polynomial of given \em order, then
359  * exact integral would be \code int getRule(int order) { return
360  * 2*(order-1); }; \endcode
361  *
362  * The integration points and weights are set appropriately for given
363  * entity type and integration rule from \ref quad.c
364  *
365  * Method \ref ForcesAndSourcesCore::getRule takes at argument takes
366  * maximal polynomial order set on the element on all fields defined on
367  * the element. If a user likes to have more control, another variant of
368  * this function can be called which distinguishing between field orders
369  * on rows, columns and data, the i.e. first argument of a bilinear form,
370  * the second argument of bilinear form and field coefficients on the
371  * element.
372  *
373  * \note If user set rule to -1 or any other negative integer, then method
374  * \ref ForcesAndSourcesCore::setGaussPts is called. In that method user
375  * can implement own (specific) integration method.
376  *
377  * \bug this function should be const
378  */
379  virtual int getRule(int order_row, int order_col, int order_data);
380 
381  /** \brief set user specific integration rule
382 
383  This function allows for user defined integration rule. The key is to
384  called matrix gaussPts, which is used by other MoFEM procedures. Matrix
385  has number of rows equal to problem dimension plus one, where last index
386  is used to store weight values. %Number of columns is equal to number of
387  integration points.
388 
389  \note This function is called if method \ref
390  ForcesAndSourcesCore::getRule is returning integer -1 or any other
391  negative integer.
392 
393  User sets
394  \code
395  MatrixDouble gaussPts;
396  \endcode
397  where
398  \code
399  gaussPts.resize(dim+1,nb_gauss_pts);
400  \endcode
401  number rows represents local coordinates of integration points
402  in reference element, where last index in row is for integration weight.
403 
404  */
405  virtual MoFEMErrorCode setGaussPts(int order_row, int order_col,
406  int order_data);
407 
408  /**
409  * \brief Calculate base functions
410  * @return Error code
411  */
413  calHierarchicalBaseFunctionsOnElement(const FieldApproximationBase b);
414 
415  /**
416  * \brief Calculate base functions
417  * @return Error code
418  */
419  MoFEMErrorCode calHierarchicalBaseFunctionsOnElement();
420 
421  /**
422  * @brief Calculate Bernstein-Bezier base
423  *
424  * @return MoFEMErrorCode
425  */
426  MoFEMErrorCode calBernsteinBezierBaseFunctionsOnElement();
427 
428  /**
429  * @brief Create a entity data on element object
430  *
431  * @return MoFEMErrorCode
432  */
433  MoFEMErrorCode createDataOnElement(EntityType type);
434 
435  /**
436  * @brief Iterate user data operators
437  *
438  * @return MoFEMErrorCode
439  */
440  MoFEMErrorCode loopOverOperators();
441 
442  /**@{*/
443 
444  /** \name Deprecated (do not use) */
445 
446  /** \deprecated Use getRule(int row_order, int col_order, int data order)
447  */
448  virtual int getRule(int order);
449 
450  /** \deprecated setGaussPts(int row_order, int col_order, int data order);
451  */
452  virtual MoFEMErrorCode setGaussPts(int order);
453 
454  /**@}*/
455 
456  /**
457  * @brief Entity data on element entity rows fields
458  *
459  */
460  const std::array<boost::shared_ptr<EntitiesFieldData>, LASTSPACE>
462 
463  /**
464  * @brief Entity data on element entity columns fields
465  *
466  */
467  const std::array<boost::shared_ptr<EntitiesFieldData>, LASTSPACE>
469 
475 
476  /**
477  * @brief Vector of finite element users data operators
478  *
479  */
480  boost::ptr_deque<UserDataOperator> opPtrVector;
481 
482  friend class UserDataOperator;
483 
484 protected:
485  /**
486  * @brief Last evaluated type of element entity
487  *
488  */
490 
491 private:
492  /**
493  * @brief Pointer to entity polynomial base
494  *
495  */
496  boost::shared_ptr<BaseFunction> elementPolynomialBasePtr;
497 
498  /**
499  * @brief Pointer to user polynomial base
500  */
501  boost::shared_ptr<BaseFunction> userPolynomialBasePtr;
502 
503  /**
504  * @brief Element to integrate on the sides
505  *
506  */
508 
509  /**
510  * @brief Set the pointer to face element on the side
511  *
512  * \note Function is is used by face element, while it iterates over
513  * elements on the side
514  *
515  * @param side_fe_ptr
516  * @return MoFEMErrorCode
517  */
518  MoFEMErrorCode setSideFEPtr(const ForcesAndSourcesCore *side_fe_ptr);
519 
520  /**u
521  * @brief Element to integrate parent or child
522  *
523  */
525 
526  /**
527  * @brief Set the pointer to face element refined
528  *
529  * @param refine_fe_ptr
530  * @return MoFEMErrorCode
531  */
532  MoFEMErrorCode setRefineFEPtr(const ForcesAndSourcesCore *refine_fe_ptr);
533 
539 
540  template <int DIM> friend struct OpCopyGeomDataToE;
541  template <typename E> friend struct OpBrokenLoopSide;
542 
543 protected:
544  MatrixDouble coordsAtGaussPts; ///< coordinated at gauss points
545  double elementMeasure; ///< Depending on dimension of elements, stores length,
546  ///< area or volume of element.
547 };
548 
550 
551  /**
552  * \brief Controls loop over entities on element
553  *
554  * - OPROW is used if row vector is assembled
555  * - OPCOL is usually used if column vector is assembled
556  * - OPROWCOL is usually used for assemble matrices.
557  * - OPSPACE no field is defined for such operator. Is usually used to modify
558  * base
559  *
560  *
561  * For typical problem like Bubnov-Galerkin OPROW and OPCOL are the same. In
562  * more general case for example for non-square matrices columns and rows
563  * could have different numeration and/or different set of fields.
564  *
565  */
566  enum OpType {
567  OPROW = 1 << 0, ///< operator doWork function is executed on FE rows
568  OPCOL = 1 << 1, ///< operator doWork function is executed on FE columns
569  OPROWCOL = 1 << 2, ///< operator doWork is executed on FE rows &columns
570  OPSPACE = 1 << 3, ///< operator do Work is execute on space data
571  OPLAST = 1 << 3 ///< @deprecated would be removed
572  };
573 
574  static const char *const OpTypeNames[];
575 
576  char opType;
577  std::string rowFieldName;
578  std::string colFieldName;
580 
581  /**
582  * This Constructor is used typically when some modification base shape
583  * functions on some approx. space is applied. Operator is run for all data
584  * on space.
585  *
586  * User has no access to field data from this operator.
587  */
588  UserDataOperator(const FieldSpace space, const char type = OPSPACE,
589  const bool symm = true);
590 
591  UserDataOperator(const std::string field_name, const char type,
592  const bool symm = true);
593 
594  UserDataOperator(const std::string row_field_name,
595  const std::string col_field_name, const char type,
596  const bool symm = true);
597 
598  /** \brief Return raw pointer to NumeredEntFiniteElement
599  */
600  inline boost::shared_ptr<const NumeredEntFiniteElement>
601  getNumeredEntFiniteElementPtr() const;
602 
603  /**
604  * \brief Return finite element entity handle
605  * @return Finite element entity handle
606  */
607  inline EntityHandle getFEEntityHandle() const;
608 
609  /**
610  * @brief Get dimension of finite element
611  *
612  * @return int
613  */
614  inline int getFEDim() const;
615 
616  /**
617  * @brief Get dimension of finite element
618  *
619  * @return int
620  */
621  inline EntityType getFEType() const;
622 
623  /**
624  * @brief Get the side number pointer
625  *
626  * \note For vertex is expectation. Side basses in argument of function doWork
627  * is zero. For other entity types side can be used as argument of this
628  * function.
629  *
630  * @param side_number
631  * @param type
632  * @return boost::weak_ptr<SideNumber>
633  */
634  inline boost::weak_ptr<SideNumber> getSideNumberPtr(const int side_number,
635  const EntityType type);
636 
637  /**
638  * @brief Get the side entity
639  *
640  * \note For vertex is expectation. Side basses in argument of function
641  * doWork is zero. For other entity types side can be used as argument of
642  * this function.
643  *
644  * \code
645  * MoFEMErrorCode doWork(int side, EntityType type,
646  * EntitiesFieldData::EntData &data) {
647  * MoFEMFunctionBegin;
648  *
649  * if (type == MBVERTEX) {
650  * for (int n = 0; n != number_of_nodes; ++n)
651  * EntityHandle ent = getSideEntity(n, type);
652  *
653  * // Do somthing
654  *
655  * } else {
656  * EntityHandle ent = getSideEntity(side, type);
657  *
658  * // Do somthing
659  *
660  * }
661  *
662  * MoFEMFunctionReturn(0);
663  * }
664  * \endcode
665  *
666  * @param side_number
667  * @param type
668  */
669  inline EntityHandle getSideEntity(const int side_number,
670  const EntityType type);
671 
672  /**
673  * @brief Get the number of nodes on finite element
674  *
675  * @return int
676  */
677  inline int getNumberOfNodesOnElement() const;
678 
679  /** \brief Get row indices
680 
681  Field could be or not declared for this element but is declared for
682  problem
683 
684  \param field_name
685  \param type entity type
686  \param side side number, any number if type is MBVERTEX
687  \return indices
688 
689  NOTE: Using those indices to assemble matrix will result in error if new
690  non-zero values need to be created.
691 
692  */
693  MoFEMErrorCode getProblemRowIndices(const std::string filed_name,
694  const EntityType type, const int side,
695  VectorInt &indices) const;
696 
697  /** \brief Get col indices
698 
699  Field could be or not declared for this element but is declared for
700  problem
701 
702  \param field_name
703  \param type entity type
704  \param side side number, any number if type is MBVERTEX
705  \return indices
706 
707  NOTE: Using those indices to assemble matrix will result in error if new
708  non-zero values need to be created.
709 
710  */
711  MoFEMErrorCode getProblemColIndices(const std::string filed_name,
712  const EntityType type, const int side,
713  VectorInt &indices) const;
714 
715  /** \brief Return raw pointer to Finite Element Method object
716  */
717  inline const FEMethod *getFEMethod() const;
718 
719  /**
720  * \brief Get operator types
721  * @return Return operator type
722  */
723  inline int getOpType() const;
724 
725  /**
726  * \brief Set operator type
727  * @param Operator type
728  */
729  inline void setOpType(const OpType type);
730 
731  /**
732  * \brief Add operator type
733  */
734  inline void addOpType(const OpType type);
735 
736  /**
737  * \brief get number of finite element in the loop
738  * @return number of finite element
739  */
740  inline int getNinTheLoop() const;
741 
742  /**
743  * \brief get size of elements in the loop
744  * @return loop size
745  */
746  inline int getLoopSize() const;
747 
748  /** \brief Get name of the element
749  */
750  inline std::string getFEName() const;
751 
752  /** \name Accessing KSP */
753 
754  /**@{*/
755 
756  inline const PetscData::Switches &getDataCtx() const;
757 
758  inline const KspMethod::KSPContext getKSPCtx() const;
759 
760  inline const SnesMethod::SNESContext getSNESCtx() const;
761 
762  inline const TSMethod::TSContext getTSCtx() const;
763 
764  /**@}*/
765 
766  /**@{*/
767 
768  inline Vec getKSPf() const;
769 
770  inline Mat getKSPA() const;
771 
772  inline Mat getKSPB() const;
773 
774  /**@}*/
775 
776  /** \name Accessing SNES */
777 
778  /**@{*/
779 
780  inline Vec getSNESf() const;
781 
782  inline Vec getSNESx() const;
783 
784  inline Mat getSNESA() const;
785 
786  inline Mat getSNESB() const;
787 
788  /**@}*/
789 
790  /** \name Accessing TS */
791 
792  /**@{*/
793 
794  inline Vec getTSu() const;
795 
796  inline Vec getTSu_t() const;
797 
798  inline Vec getTSu_tt() const;
799 
800  inline Vec getTSf() const;
801 
802  inline Mat getTSA() const;
803 
804  inline Mat getTSB() const;
805 
806  inline int getTSstep() const;
807 
808  inline double getTStime() const;
809 
810  inline double getTStimeStep() const;
811 
812  inline double getTSa() const;
813 
814  inline double getTSaa() const;
815 
816  /**@}*/
817 
818  /**@{*/
819 
820  /** \name Base funtions and integration points */
821 
822  /** \brief matrix of integration (Gauss) points for Volume Element
823  *
824  * For triangle: columns 0,1 are x,y coordinates respectively and column
825  * 2 is a weight value for example getGaussPts()(1,13) returns y
826  * coordinate of 13th Gauss point on particular volume element
827  *
828  * For tetrahedron: columns 0,1,2 are x,y,z coordinates respectively and
829  * column 3 is a weight value for example getGaussPts()(1,13) returns y
830  * coordinate of 13th Gauss point on particular volume element
831  *
832  */
833  inline MatrixDouble &getGaussPts();
834 
835  /**
836  * @brief Get integration weights
837  *
838  * \code
839  * auto t_w = getFTensor0IntegrationWeight();
840  * for(int gg = 0; gg!=getGaussPts.size2(); ++gg) {
841  * // integrate something
842  * ++t_w;
843  * }
844  * \endcode
845  *
846  * @return FTensor::Tensor0<FTensor::PackPtr<double *, 1>>
847  */
848  inline auto getFTensor0IntegrationWeight();
849 
850  /**@}*/
851 
852  /** \name Coordinates and access to internal data */
853 
854  /**@{*/
855 
856  /** \brief Gauss points and weight, matrix (nb. of points x 3)
857 
858  Column 0-2 integration points coordinate x, y and z, respectively. At rows
859  are integration points.
860 
861  */
862  inline MatrixDouble &getCoordsAtGaussPts();
863 
864  /**
865  * \brief Get coordinates at integration points assuming linear geometry
866  *
867  * \code
868  * auto t_coords = getFTensor1CoordsAtGaussPts();
869  * for(int gg = 0;gg!=nb_int_ptrs;gg++) {
870  * // do something
871  * ++t_coords;
872  * }
873  * \endcode
874  *
875  */
876  inline auto getFTensor1CoordsAtGaussPts();
877 
878  /**@}*/
879 
880  /**@{*/
881 
882  /** \name Measures (area, volume, length, etc.) */
883 
884  /**
885  * \brief get measure of element
886  * @return volume
887  */
888  inline double getMeasure() const;
889 
890  /**
891  * \brief get measure of element
892  * @return volume
893  */
894  inline double &getMeasure();
895 
896  /**}*/
897 
898  /**@{*/
899 
900  /** \name Loops */
901 
902  using AdjCache =
903  std::map<EntityHandle,
904  std::vector<boost::weak_ptr<NumeredEntFiniteElement>>>;
905 
906  /**
907  * @brief User calls this function to loop over elements on the side of
908  * face. This function calls finite element with its operator to do
909  * calculations.
910  *
911  * @param fe_name name of the side element
912  * @param side_fe pointer to the side element instance
913  * @param dim dimension the of side element
914  * @param ent_for_side entity handle for which adjacent volume or face will
915  * be accessed
916  * @param verb
917  * @param sev
918  * @param adj_cache
919  * @return MoFEMErrorCode
920  */
921  MoFEMErrorCode loopSide(const string &fe_name, ForcesAndSourcesCore *side_fe,
922  const size_t dim, const EntityHandle ent_for_side = 0,
923  const int verb = QUIET,
924  const LogManager::SeverityLevel sev = Sev::noisy,
925  AdjCache *adj_cache = nullptr
926 
927  );
928 
929  /**
930  * @brief User calls this function to loop over the same element using a
931  * different set of integration points. This function calls finite element
932  * with its operator to do calculations.
933  *
934  * @param fe_name
935  * @param this_fe
936  * @param verb
937  * @param sev
938  * @return MoFEMErrorCode
939  */
940  MoFEMErrorCode loopThis(const string &fe_name,
941  ForcesAndSourcesCore *this_fe,
942  const int verb = QUIET,
943  const LogManager::SeverityLevel sev = Sev::noisy);
944 
945  /**
946  * @brief User calls this function to loop over parent elements. This function
947  * calls finite element with its operator to do calculations.
948  *
949  * @param fe_name
950  * @param parent_fe
951  * @param verb
952  * @param sev
953  * @return MoFEMErrorCode
954  */
955  MoFEMErrorCode loopParent(const string &fe_name,
956  ForcesAndSourcesCore *parent_fe,
957  const int verb = QUIET,
958  const LogManager::SeverityLevel sev = Sev::noisy);
959 
960  /**
961  * @brief User calls this function to loop over parent elements. This function
962  * calls finite element with its operator to do calculations.
963  *
964  * @param fe_name
965  * @param child_fe
966  * @param verb
967  * @param sev
968  * @return MoFEMErrorCode
969  */
970  MoFEMErrorCode loopChildren(const string &fe_name,
971  ForcesAndSourcesCore *child_fe,
972  const int verb = QUIET,
973  const LogManager::SeverityLevel sev = Sev::noisy);
974 
975  /**@}*/
976 
977  inline ForcesAndSourcesCore *getPtrFE() const;
978 
979  inline ForcesAndSourcesCore *getSidePtrFE() const;
980 
981  inline ForcesAndSourcesCore *getRefinePtrFE() const;
982 
983 
984 protected:
986 
987  virtual MoFEMErrorCode setPtrFE(ForcesAndSourcesCore *ptr);
988 
989 private:
990  friend class ForcesAndSourcesCore;
994 };
995 
996 /// \deprecated Used ForcesAndSourcesCore instead
998 
999 boost::shared_ptr<const NumeredEntFiniteElement>
1000 ForcesAndSourcesCore::UserDataOperator::getNumeredEntFiniteElementPtr() const {
1001  return ptrFE->numeredEntFiniteElementPtr;
1002 };
1003 
1004 EntityHandle ForcesAndSourcesCore::UserDataOperator::getFEEntityHandle() const {
1005  return getNumeredEntFiniteElementPtr()->getEnt();
1006 }
1007 
1008 int ForcesAndSourcesCore::UserDataOperator::getFEDim() const {
1009  return dimension_from_handle(getFEEntityHandle());
1010 };
1011 
1012 EntityType ForcesAndSourcesCore::UserDataOperator::getFEType() const {
1013  return type_from_handle(getFEEntityHandle());
1014 };
1015 
1016 boost::weak_ptr<SideNumber>
1017 ForcesAndSourcesCore::UserDataOperator::getSideNumberPtr(
1018  const int side_number, const EntityType type) {
1019  auto &side_table_by_side_and_type =
1020  ptrFE->numeredEntFiniteElementPtr->getSideNumberTable().get<1>();
1021  auto side_it =
1022  side_table_by_side_and_type.find(boost::make_tuple(type, side_number));
1023  if (side_it != side_table_by_side_and_type.end())
1024  return *side_it;
1025  else
1026  return boost::weak_ptr<SideNumber>();
1027 }
1028 
1030 ForcesAndSourcesCore::UserDataOperator::getSideEntity(const int side_number,
1031  const EntityType type) {
1032  if (auto side_ptr = getSideNumberPtr(side_number, type).lock())
1033  return side_ptr->ent;
1034  else
1035  return 0;
1036 }
1037 
1038 int ForcesAndSourcesCore::UserDataOperator::getNumberOfNodesOnElement() const {
1039  return ptrFE->getNumberOfNodes();
1040 }
1041 
1042 const FEMethod *ForcesAndSourcesCore::UserDataOperator::getFEMethod() const {
1043  return ptrFE;
1044 }
1045 
1046 int ForcesAndSourcesCore::UserDataOperator::getOpType() const { return opType; }
1047 
1048 void ForcesAndSourcesCore::UserDataOperator::setOpType(const OpType type) {
1049  opType = type;
1050 }
1051 
1052 void ForcesAndSourcesCore::UserDataOperator::addOpType(const OpType type) {
1053  opType |= type;
1054 }
1055 
1056 int ForcesAndSourcesCore::UserDataOperator::getNinTheLoop() const {
1057  return getFEMethod()->getNinTheLoop();
1058 }
1059 
1060 int ForcesAndSourcesCore::UserDataOperator::getLoopSize() const {
1061  return getFEMethod()->getLoopSize();
1062 }
1063 
1064 std::string ForcesAndSourcesCore::UserDataOperator::getFEName() const {
1065  return getFEMethod()->getFEName();
1066 }
1067 
1068 const PetscData::Switches &
1069 ForcesAndSourcesCore::UserDataOperator::getDataCtx() const {
1070  return getFEMethod()->data_ctx;
1071 }
1072 
1074 ForcesAndSourcesCore::UserDataOperator::getKSPCtx() const {
1075  return getFEMethod()->ksp_ctx;
1076 }
1077 
1079 ForcesAndSourcesCore::UserDataOperator::getSNESCtx() const {
1080  return getFEMethod()->snes_ctx;
1081 }
1082 
1083 const TSMethod::TSContext
1084 ForcesAndSourcesCore::UserDataOperator::getTSCtx() const {
1085  return getFEMethod()->ts_ctx;
1086 }
1087 
1088 Vec ForcesAndSourcesCore::UserDataOperator::getKSPf() const {
1089 #ifndef NDEBUG
1090  if (getFEMethod()->ksp_f == PETSC_NULL)
1091  THROW_MESSAGE("KSP not set F vector");
1092 #endif
1093  return getFEMethod()->ksp_f;
1094 }
1095 
1096 Mat ForcesAndSourcesCore::UserDataOperator::getKSPA() const {
1097 #ifndef NDEBUG
1098  if (getFEMethod()->ksp_A == PETSC_NULL)
1099  THROW_MESSAGE("KSP not set A vector");
1100 #endif
1101  return getFEMethod()->ksp_A;
1102 }
1103 
1104 Mat ForcesAndSourcesCore::UserDataOperator::getKSPB() const {
1105 #ifndef NDEBUG
1106  if (getFEMethod()->ksp_B == PETSC_NULL)
1107  THROW_MESSAGE("KSP not set B vector");
1108 #endif
1109  return getFEMethod()->ksp_B;
1110 }
1111 
1112 Vec ForcesAndSourcesCore::UserDataOperator::getSNESf() const {
1113 #ifndef NDEBUG
1114  if (getFEMethod()->snes_f == PETSC_NULL)
1115  THROW_MESSAGE("SNES not set F vector");
1116 #endif
1117  return getFEMethod()->snes_f;
1118 }
1119 
1120 Vec ForcesAndSourcesCore::UserDataOperator::getSNESx() const {
1121 #ifndef NDEBUG
1122  if (getFEMethod()->snes_x == PETSC_NULL)
1123  THROW_MESSAGE("SNESnot set X vector");
1124 #endif
1125  return getFEMethod()->snes_x;
1126 }
1127 
1128 Mat ForcesAndSourcesCore::UserDataOperator::getSNESA() const {
1129 #ifndef NDEBUG
1130  if (getFEMethod()->snes_A == PETSC_NULL)
1131  THROW_MESSAGE("SNES not set A vector");
1132 #endif
1133  return getFEMethod()->snes_A;
1134 }
1135 
1136 Mat ForcesAndSourcesCore::UserDataOperator::getSNESB() const {
1137 #ifndef NDEBUG
1138  if (getFEMethod()->snes_B == PETSC_NULL)
1139  THROW_MESSAGE("SNES not set A matrix");
1140 #endif
1141  return getFEMethod()->snes_B;
1142 }
1143 
1144 Vec ForcesAndSourcesCore::UserDataOperator::getTSu() const {
1145 #ifndef NDEBUG
1146  if (getFEMethod()->ts_u == PETSC_NULL)
1147  THROW_MESSAGE("TS not set U vector");
1148 #endif
1149  return getFEMethod()->ts_u;
1150 }
1151 
1152 Vec ForcesAndSourcesCore::UserDataOperator::getTSu_t() const {
1153 #ifndef NDEBUG
1154  if (getFEMethod()->ts_u_t == PETSC_NULL)
1155  THROW_MESSAGE("TS not set U_t vector");
1156 #endif
1157  return getFEMethod()->ts_u_t;
1158 }
1159 
1160 Vec ForcesAndSourcesCore::UserDataOperator::getTSu_tt() const {
1161 #ifndef NDEBUG
1162  if (getFEMethod()->ts_u_tt == PETSC_NULL)
1163  THROW_MESSAGE("TS not set U_tt vector");
1164 #endif
1165  return getFEMethod()->ts_u_tt;
1166 }
1167 
1168 Vec ForcesAndSourcesCore::UserDataOperator::getTSf() const {
1169 #ifndef NDEBUG
1170  if (getFEMethod()->ts_F == PETSC_NULL)
1171  THROW_MESSAGE("TS not set F vector");
1172 #endif
1173  return getFEMethod()->ts_F;
1174 }
1175 
1176 Mat ForcesAndSourcesCore::UserDataOperator::getTSA() const {
1177 #ifndef NDEBUG
1178  if (getFEMethod()->ts_A == PETSC_NULL)
1179  THROW_MESSAGE("TS not set A matrix");
1180 #endif
1181  return getFEMethod()->ts_A;
1182 }
1183 
1184 Mat ForcesAndSourcesCore::UserDataOperator::getTSB() const {
1185 #ifndef NDEBUG
1186  if (getFEMethod()->ts_B == PETSC_NULL)
1187  THROW_MESSAGE("TS not set B matrix");
1188 #endif
1189  return getFEMethod()->ts_B;
1190 }
1191 
1192 int ForcesAndSourcesCore::UserDataOperator::getTSstep() const {
1193 #ifndef NDEBUG
1194  if ((getFEMethod()->data_ctx & PetscData::PetscData::CtxSetTime).none())
1195  THROW_MESSAGE("TS not set time");
1196 #endif
1197  return getFEMethod()->ts_step;
1198 }
1199 
1200 double ForcesAndSourcesCore::UserDataOperator::getTStime() const {
1201 #ifndef NDEBUG
1202  if ((getFEMethod()->data_ctx & PetscData::PetscData::CtxSetTime).none())
1203  THROW_MESSAGE("TS not set time");
1204 #endif
1205  return getFEMethod()->ts_t;
1206 }
1207 
1208 double ForcesAndSourcesCore::UserDataOperator::getTStimeStep() const {
1209 #ifndef NDEBUG
1210  if ((getFEMethod()->data_ctx & PetscData::PetscData::CtxSetTime).none())
1211  THROW_MESSAGE("TS not set time");
1212 #endif
1213  return getFEMethod()->ts_dt;
1214 }
1215 
1216 double ForcesAndSourcesCore::UserDataOperator::getTSa() const {
1217 #ifndef NDEBUG
1218  if ((getFEMethod()->data_ctx & (PetscData::CtxSetA | PetscData::CtxSetB))
1219  .none() ||
1220  (getFEMethod()->data_ctx & (PetscData::CtxSetX_T)).none())
1221  THROW_MESSAGE("TS not set B matrix");
1222 #endif
1223  return getFEMethod()->ts_a;
1224 }
1225 
1226 double ForcesAndSourcesCore::UserDataOperator::getTSaa() const {
1227 #ifndef NDEBUG
1228  if ((getFEMethod()->data_ctx & (PetscData::CtxSetA | PetscData::CtxSetB))
1229  .none() ||
1230  (getFEMethod()->data_ctx & (PetscData::CtxSetX_TT)).none())
1231  THROW_MESSAGE("TS not set B matrix");
1232 #endif
1233  return getFEMethod()->ts_aa;
1234 }
1235 
1236 MatrixDouble &ForcesAndSourcesCore::UserDataOperator::getGaussPts() {
1237  return static_cast<ForcesAndSourcesCore *>(ptrFE)->gaussPts;
1238 }
1239 
1240 auto ForcesAndSourcesCore::UserDataOperator::getFTensor0IntegrationWeight() {
1242  &(getGaussPts()(getGaussPts().size1() - 1, 0)));
1243 }
1244 
1245 // MoFEMErrorCode ForcesAndSourcesCore::UserDataOperator::getPorblemRowIndices(
1246 // const std::string filed_name, const EntityType type, const int side,
1247 // VectorInt &indices) const {
1248 // return getProblemRowIndices(filed_name, type, side, indices);
1249 // }
1250 
1251 ForcesAndSourcesCore *ForcesAndSourcesCore::UserDataOperator::getPtrFE() const {
1252  return ptrFE;
1253 }
1254 
1256 ForcesAndSourcesCore::UserDataOperator::getSidePtrFE() const {
1257  return ptrFE->sidePtrFE;
1258 }
1259 
1261 ForcesAndSourcesCore::UserDataOperator::getRefinePtrFE() const {
1262  return ptrFE->refinePtrFE;
1263 }
1264 
1265 MatrixDouble &ForcesAndSourcesCore::UserDataOperator::getCoordsAtGaussPts() {
1266  return static_cast<ForcesAndSourcesCore *>(ptrFE)->coordsAtGaussPts;
1267 }
1268 
1269 auto ForcesAndSourcesCore::UserDataOperator::getFTensor1CoordsAtGaussPts() {
1271  &getCoordsAtGaussPts()(0, 0), &getCoordsAtGaussPts()(0, 1),
1272  &getCoordsAtGaussPts()(0, 2));
1273 }
1274 
1275 double ForcesAndSourcesCore::UserDataOperator::getMeasure() const {
1276  return static_cast<ForcesAndSourcesCore *>(ptrFE)->elementMeasure;
1277 }
1278 
1279 double &ForcesAndSourcesCore::UserDataOperator::getMeasure() {
1280  return static_cast<ForcesAndSourcesCore *>(ptrFE)->elementMeasure;
1281 }
1282 
1283 /**
1284  * @brief Element used to execute operators on side of the element
1285  *
1286  * @tparam E template for side element type
1287  *
1288  */
1289 template <typename E>
1291 
1293 
1294  /**
1295  * @brief Construct a new Op Loop Side object
1296  *
1297  * @param m_field
1298  * @param fe_name name of side (domain element)
1299  * @param side_dim dimension
1300  * @param sev severity level
1301  * @param adj_cache if set to null cache of the element is used
1302  */
1303  OpLoopSide(MoFEM::Interface &m_field, const std::string fe_name,
1304  const int side_dim,
1305  const LogManager::SeverityLevel sev = Sev::noisy,
1306  boost::shared_ptr<AdjCache> adj_cache = nullptr)
1307  : UserDataOperator(NOSPACE, OPSPACE), sideFEPtr(new E(m_field)),
1308  sideFEName(fe_name), sideDim(side_dim), sevLevel(sev),
1309  adjCache(adj_cache) {}
1310 
1311  MoFEMErrorCode doWork(int side, EntityType type,
1314  CHKERR loopSide(sideFEName, sideFEPtr.get(), sideDim, 0, VERBOSE, sevLevel,
1315  adjCache.get());
1317  };
1318 
1319  boost::ptr_deque<UserDataOperator> &getOpPtrVector() {
1320  return sideFEPtr->getOpPtrVector();
1321  }
1322 
1323  boost::shared_ptr<E> &getSideFEPtr() { return sideFEPtr; }
1324 
1325 protected:
1326  const std::string sideFEName;
1327  const int sideDim;
1328  boost::shared_ptr<E> sideFEPtr;
1330  boost::shared_ptr<AdjCache> adjCache;
1331 };
1332 
1333 /**
1334  * \brief Copy geometry-related data from one element to other
1335  *
1336  * That can be used to copy high order geometry data from coarse element to
1337  * children. That is often a case when higher order geometry is defined only on
1338  * coarse elements.
1339  *
1340  * \note Integration points have to be located at the same gometric positions
1341  *
1342  * FIXME: Write atom test
1343  */
1344 template <int DIM> struct OpCopyGeomDataToE;
1345 
1346 } // namespace MoFEM
1347 
1348 #endif //__FORCES_AND_SOURCES_CORE__HPP__
1349 
1350 /**
1351  * \defgroup mofem_forces_and_sources Forces and sources
1352  * \ingroup mofem
1353  *
1354  * \brief Manages complexities related to assembly of vector and matrices at
1355  * single finite element level.
1356  *
1357  **/
UBlasMatrix< double >
MoFEM::ForcesAndSourcesCore::dataNoField
EntitiesFieldData & dataNoField
Definition: ForcesAndSourcesCore.hpp:470
NOSPACE
@ NOSPACE
Definition: definitions.h:83
MoFEM::PetscData::Switches
std::bitset< 8 > Switches
Definition: LoopMethods.hpp:33
MoFEM::EdgeElementForcesAndSourcesCore
Edge finite element.
Definition: EdgeElementForcesAndSourcesCore.hpp:30
MoFEM::SnesMethod::SNESContext
SNESContext
Definition: LoopMethods.hpp:107
MoFEM::dimension_from_handle
auto dimension_from_handle(const EntityHandle h)
get entity dimension form handle
Definition: Templates.hpp:1892
MoFEM::EntitiesFieldData::EntData
Data on single entity (This is passed as argument to DataOperator::doWork)
Definition: EntitiesFieldData.hpp:128
MoFEM::ForcesAndSourcesCore::UserDataOperator::AdjCache
std::map< EntityHandle, std::vector< boost::weak_ptr< NumeredEntFiniteElement > >> AdjCache
Definition: ForcesAndSourcesCore.hpp:904
MoFEM::ForcesAndSourcesCore::getDerivedDataOnElementBySpaceArray
auto & getDerivedDataOnElementBySpaceArray()
Get derived data on entities and space.
Definition: ForcesAndSourcesCore.hpp:167
DEPRECATED
#define DEPRECATED
Definition: definitions.h:17
MoFEM::DataOperator
base operator to do operations at Gauss Pt. level
Definition: DataOperators.hpp:24
FTensor::Tensor1
Definition: Tensor1_value.hpp:8
EntityHandle
MoFEM::ForcesAndSourcesCore::derivedDataOnElement
const std::array< boost::shared_ptr< EntitiesFieldData >, LASTSPACE > derivedDataOnElement
Entity data on element entity columns fields.
Definition: ForcesAndSourcesCore.hpp:468
MoFEM::FEMethod
structure for User Loop Methods on finite elements
Definition: LoopMethods.hpp:369
MoFEM::ForcesAndSourcesCore::lastEvaluatedElementEntityType
EntityType lastEvaluatedElementEntityType
Last evaluated type of element entity.
Definition: ForcesAndSourcesCore.hpp:489
MoFEM::ForcesAndSourcesCore::getRuleHook
RuleHookFun getRuleHook
Hook to get rule.
Definition: ForcesAndSourcesCore.hpp:42
MoFEM::OpLoopSide::sideFEName
const std::string sideFEName
Definition: ForcesAndSourcesCore.hpp:1326
MoFEM::ForcesAndSourcesCore::GaussHookFun
boost::function< MoFEMErrorCode(ForcesAndSourcesCore *fe_raw_ptr, int order_row, int order_col, int order_data)> GaussHookFun
Definition: ForcesAndSourcesCore.hpp:33
MoFEM::Exceptions::MoFEMErrorCode
PetscErrorCode MoFEMErrorCode
MoFEM/PETSc error code.
Definition: Exceptions.hpp:56
E
MoFEM::FieldEntity_vector_view
std::vector< boost::weak_ptr< FieldEntity > > FieldEntity_vector_view
Definition: FieldEntsMultiIndices.hpp:478
MoFEM::ForcesAndSourcesCore::UserDataOperator::OpType
OpType
Controls loop over entities on element.
Definition: ForcesAndSourcesCore.hpp:566
MoFEM::ForcesAndSourcesCore::dataHdiv
EntitiesFieldData & dataHdiv
Definition: ForcesAndSourcesCore.hpp:473
MoFEM::ForcesAndSurcesCore
DEPRECATED typedef ForcesAndSourcesCore ForcesAndSurcesCore
Definition: ForcesAndSourcesCore.hpp:997
MoFEM::OpLoopSide::sideDim
const int sideDim
Definition: ForcesAndSourcesCore.hpp:1327
MoFEM::ForcesAndSourcesCore::sidePtrFE
ForcesAndSourcesCore * sidePtrFE
Element to integrate on the sides.
Definition: ForcesAndSourcesCore.hpp:507
MoFEM::OpLoopSide::getSideFEPtr
boost::shared_ptr< E > & getSideFEPtr()
Definition: ForcesAndSourcesCore.hpp:1323
MoFEM::ForcesAndSourcesCore::UserDataOperator::rowFieldName
std::string rowFieldName
Definition: ForcesAndSourcesCore.hpp:577
MoFEM::ForcesAndSourcesCore::getElementPolynomialBase
auto & getElementPolynomialBase()
Get the Entity Polynomial Base object.
Definition: ForcesAndSourcesCore.hpp:90
THROW_MESSAGE
#define THROW_MESSAGE(msg)
Throw MoFEM exception.
Definition: definitions.h:574
order
constexpr int order
Definition: dg_projection.cpp:18
MoFEM::DeprecatedCoreInterface
Deprecated interface functions.
Definition: DeprecatedCoreInterface.hpp:16
MoFEM::OpLoopSide::sideFEPtr
boost::shared_ptr< E > sideFEPtr
Definition: ForcesAndSourcesCore.hpp:1328
NumeredDofEntity_multiIndex
multi_index_container< boost::shared_ptr< NumeredDofEntity >, indexed_by< ordered_unique< tag< Unique_mi_tag >, const_mem_fun< NumeredDofEntity::interface_type_DofEntity, UId, &NumeredDofEntity::getLocalUniqueId > >, ordered_non_unique< tag< Part_mi_tag >, member< NumeredDofEntity, unsigned int, &NumeredDofEntity::pArt > >, ordered_non_unique< tag< Idx_mi_tag >, member< NumeredDofEntity, DofIdx, &NumeredDofEntity::dofIdx > >, ordered_non_unique< tag< PetscGlobalIdx_mi_tag >, member< NumeredDofEntity, DofIdx, &NumeredDofEntity::petscGloablDofIdx > >, ordered_non_unique< tag< PetscLocalIdx_mi_tag >, member< NumeredDofEntity, DofIdx, &NumeredDofEntity::petscLocalDofIdx > >, ordered_non_unique< tag< Ent_mi_tag >, const_mem_fun< NumeredDofEntity::interface_type_DofEntity, EntityHandle, &NumeredDofEntity::getEnt > > > > NumeredDofEntity_multiIndex
MultiIndex container keeps NumeredDofEntity.
Definition: DofsMultiIndices.hpp:469
FieldSpace
FieldSpace
approximation spaces
Definition: definitions.h:82
MoFEM::ForcesAndSourcesCore::dataL2
EntitiesFieldData & dataL2
Definition: ForcesAndSourcesCore.hpp:474
VERBOSE
@ VERBOSE
Definition: definitions.h:222
MoFEM::ForcesAndSourcesCore::elementMeasure
double elementMeasure
Definition: ForcesAndSourcesCore.hpp:545
MoFEM::ContactPrismElementForcesAndSourcesCore
ContactPrism finite element.
Definition: ContactPrismElementForcesAndSourcesCore.hpp:27
CHKERR
#define CHKERR
Inline error check.
Definition: definitions.h:548
MoFEM::OpBrokenLoopSide
Definition: FormsBrokenSpaceConstraintImpl.hpp:15
MoFEM::OpLoopSide::doWork
MoFEMErrorCode doWork(int side, EntityType type, EntitiesFieldData::EntData &data)
Operator for linear form, usually to calculate values on right hand side.
Definition: ForcesAndSourcesCore.hpp:1311
MoFEM::ForcesAndSourcesCore::UserDataOperator::colFieldName
std::string colFieldName
Definition: ForcesAndSourcesCore.hpp:578
MoFEM::ForcesAndSourcesCore::refinePtrFE
ForcesAndSourcesCore * refinePtrFE
Element to integrate parent or child.
Definition: ForcesAndSourcesCore.hpp:524
MoFEM::ForcesAndSourcesCore::getUserPolynomialBase
auto & getUserPolynomialBase()
Get the User Polynomial Base object.
Definition: ForcesAndSourcesCore.hpp:97
MoFEM
implementation of Data Operators for Forces and Sources
Definition: Common.hpp:10
MoFEM::ForcesAndSourcesCore::coordsAtGaussPts
MatrixDouble coordsAtGaussPts
coordinated at gauss points
Definition: ForcesAndSourcesCore.hpp:544
MoFEM::OpLoopSide::OpLoopSide
OpLoopSide(MoFEM::Interface &m_field, const std::string fe_name, const int side_dim, const LogManager::SeverityLevel sev=Sev::noisy, boost::shared_ptr< AdjCache > adj_cache=nullptr)
Construct a new Op Loop Side object.
Definition: ForcesAndSourcesCore.hpp:1303
MoFEM::VolumeElementForcesAndSourcesCoreOnContactPrismSide
Base volume element used to integrate on contact surface (could be extended to other volume elements)
Definition: VolumeElementForcesAndSourcesCoreOnContactPrismSide.hpp:23
MoFEM::ForcesAndSourcesCore::UserDataOperator
Definition: ForcesAndSourcesCore.hpp:549
MoFEM::OpCopyGeomDataToE
Copy geometry-related data from one element to other.
Definition: ForcesAndSourcesCore.hpp:1344
MoFEM::OpLoopSide::sevLevel
const LogManager::SeverityLevel sevLevel
Definition: ForcesAndSourcesCore.hpp:1329
MoFEM::KspMethod::KSPContext
KSPContext
pass information about context of KSP/DM for with finite element is computed
Definition: LoopMethods.hpp:73
convert.type
type
Definition: convert.py:64
MoFEM::ForcesAndSourcesCore::UserDataOperator::opType
char opType
Definition: ForcesAndSourcesCore.hpp:576
MoFEM::ForcesAndSourcesCore::opPtrVector
boost::ptr_deque< UserDataOperator > opPtrVector
Vector of finite element users data operators.
Definition: ForcesAndSourcesCore.hpp:480
MoFEM::ForcesAndSourcesCore::dataOnElement
const std::array< boost::shared_ptr< EntitiesFieldData >, LASTSPACE > dataOnElement
Entity data on element entity rows fields.
Definition: ForcesAndSourcesCore.hpp:461
MoFEM::VectorDofs
ublas::vector< FEDofEntity *, DofsAllocator > VectorDofs
Definition: EntitiesFieldData.hpp:23
MoFEM::FaceElementForcesAndSourcesCoreOnChildParent
Base face element used to integrate on skeleton.
Definition: FaceElementForcesAndSourcesCoreOnParent.hpp:19
LASTSPACE
@ LASTSPACE
FieldSpace in [ 0, LASTSPACE )
Definition: definitions.h:89
MoFEM::ForcesAndSourcesCore::userPolynomialBasePtr
boost::shared_ptr< BaseFunction > userPolynomialBasePtr
Pointer to user polynomial base.
Definition: ForcesAndSourcesCore.hpp:501
MoFEM::ForcesAndSourcesCore::getEntData
auto & getEntData(const FieldSpace space, const EntityType type, const int side)
Get the entity data.
Definition: ForcesAndSourcesCore.hpp:144
MoFEM::FaceElementForcesAndSourcesCore
Face finite element.
Definition: FaceElementForcesAndSourcesCore.hpp:23
MoFEM::type_from_handle
auto type_from_handle(const EntityHandle h)
get type from entity handle
Definition: Templates.hpp:1876
MoFEM::LogManager::SeverityLevel
SeverityLevel
Severity levels.
Definition: LogManager.hpp:33
MoFEM::ForcesAndSourcesCore::getEntityDataOrder
MoFEMErrorCode getEntityDataOrder(EntitiesFieldData &data, const FieldSpace space) const
Get the entity data order for given space.
Definition: ForcesAndSourcesCore.hpp:213
field_name
constexpr auto field_name
Definition: poisson_2d_homogeneous.cpp:13
MoFEM::ForcesAndSourcesCore
structure to get information form mofem into EntitiesFieldData
Definition: ForcesAndSourcesCore.hpp:22
MoFEM::ForcesAndSourcesCore::dataH1
EntitiesFieldData & dataH1
Definition: ForcesAndSourcesCore.hpp:471
MoFEM::TSMethod::TSContext
TSContext
Definition: LoopMethods.hpp:139
FTensor::Tensor0
Definition: Tensor0.hpp:16
MoFEM::EdgeElementForcesAndSourcesCoreOnChildParent
Base face element used to integrate on skeleton.
Definition: EdgeElementForcesAndSourcesCoreOnParent.hpp:19
MoFEM::ForcesAndSourcesCore::getEntitySense
MoFEMErrorCode getEntitySense(EntitiesFieldData &data) const
Get the entity sense (orientation)
Definition: ForcesAndSourcesCore.hpp:200
UserDataOperator
ForcesAndSourcesCore::UserDataOperator UserDataOperator
Definition: HookeElement.hpp:75
MoFEM::Types::VectorInt
UBlasVector< int > VectorInt
Definition: Types.hpp:67
MoFEM::ForcesAndSourcesCore::dataHcurl
EntitiesFieldData & dataHcurl
Definition: ForcesAndSourcesCore.hpp:472
UBlasVector< double >
MoFEM::ForcesAndSourcesCore::getOpPtrVector
boost::ptr_deque< UserDataOperator > & getOpPtrVector()
Use to push back operator for row operator.
Definition: ForcesAndSourcesCore.hpp:83
EigenMatrix::Vec
const FTensor::Tensor2< T, Dim, Dim > Vec
Definition: MatrixFunction.hpp:66
MoFEM::ForcesAndSourcesCore::gaussPts
MatrixDouble gaussPts
Matrix of integration points.
Definition: ForcesAndSourcesCore.hpp:109
MoFEM::ForcesAndSourcesCore::UserDataOperator::sPace
FieldSpace sPace
Definition: ForcesAndSourcesCore.hpp:579
MoFEM::ForcesAndSourcesCore::elementPolynomialBasePtr
boost::shared_ptr< BaseFunction > elementPolynomialBasePtr
Pointer to entity polynomial base.
Definition: ForcesAndSourcesCore.hpp:496
FieldApproximationBase
FieldApproximationBase
approximation base
Definition: definitions.h:58
MoFEM::ForcesAndSourcesCore::getDataOnElementBySpaceArray
auto & getDataOnElementBySpaceArray()
Get data on entities and space.
Definition: ForcesAndSourcesCore.hpp:156
MoFEM::EntitiesFieldData::dataOnEntities
std::array< boost::ptr_vector< EntData >, MBMAXTYPE > dataOnEntities
Definition: EntitiesFieldData.hpp:57
MoFEM::VectorFieldEntities
ublas::vector< FieldEntity *, FieldEntAllocator > VectorFieldEntities
Definition: EntitiesFieldData.hpp:31
MoFEM::ForcesAndSourcesCore::setRuleHook
GaussHookFun setRuleHook
Set function to calculate integration rule.
Definition: ForcesAndSourcesCore.hpp:48
MoFEM::FEMethod::numeredEntFiniteElementPtr
boost::shared_ptr< const NumeredEntFiniteElement > numeredEntFiniteElementPtr
Definition: LoopMethods.hpp:383
QUIET
@ QUIET
Definition: definitions.h:221
MoFEM::VolumeElementForcesAndSourcesCoreOnSide
Base volume element used to integrate on skeleton.
Definition: VolumeElementForcesAndSourcesCoreOnSide.hpp:22
MoFEM::EntitiesFieldData
data structure for finite element entity
Definition: EntitiesFieldData.hpp:40
MoFEM::OpLoopSide::getOpPtrVector
boost::ptr_deque< UserDataOperator > & getOpPtrVector()
Definition: ForcesAndSourcesCore.hpp:1319
convert.int
int
Definition: convert.py:64
MoFEMFunctionReturn
#define MoFEMFunctionReturn(a)
Last executable line of each PETSc function used for error handling. Replaces return()
Definition: definitions.h:429
MoFEM::OpLoopSide::adjCache
boost::shared_ptr< AdjCache > adjCache
Definition: ForcesAndSourcesCore.hpp:1330
MoFEM::ForcesAndSourcesCore::RuleHookFun
boost::function< int(int order_row, int order_col, int order_data)> RuleHookFun
Definition: ForcesAndSourcesCore.hpp:28
MoFEM::ForcesAndSourcesCore::UserDataOperator::ptrFE
ForcesAndSourcesCore * ptrFE
Definition: ForcesAndSourcesCore.hpp:985
MoFEM::FaceElementForcesAndSourcesCoreOnSide
Base face element used to integrate on skeleton.
Definition: FaceElementForcesAndSourcesCoreOnSide.hpp:19
MoFEM::OpLoopSide
Element used to execute operators on side of the element.
Definition: ForcesAndSourcesCore.hpp:1290
MoFEMFunctionBegin
#define MoFEMFunctionBegin
First executable line of each MoFEM function, used for error handling. Final line of MoFEM functions ...
Definition: definitions.h:359
MoFEM::ForcesAndSourcesCore::mField
Interface & mField
Definition: ForcesAndSourcesCore.hpp:24