Reference documentation for deal.II version 9.0.0
integration_info.h
1 // ---------------------------------------------------------------------
2 //
3 // Copyright (C) 2006 - 2018 by the deal.II authors
4 //
5 // This file is part of the deal.II library.
6 //
7 // The deal.II library is free software; you can use it, redistribute
8 // it, and/or modify it under the terms of the GNU Lesser General
9 // Public License as published by the Free Software Foundation; either
10 // version 2.1 of the License, or (at your option) any later version.
11 // The full text of the license can be found in the file LICENSE at
12 // the top level of the deal.II distribution.
13 //
14 // ---------------------------------------------------------------------
15 
16 
17 #ifndef dealii_mesh_worker_integration_info_h
18 #define dealii_mesh_worker_integration_info_h
19 
20 #include <deal.II/base/config.h>
21 #include <deal.II/base/quadrature_lib.h>
22 #include <deal.II/dofs/block_info.h>
23 #include <deal.II/fe/fe_values.h>
24 #include <deal.II/meshworker/local_results.h>
25 #include <deal.II/meshworker/dof_info.h>
26 #include <deal.II/meshworker/vector_selector.h>
27 
28 #include <memory>
29 
30 DEAL_II_NAMESPACE_OPEN
31 
32 namespace MeshWorker
33 {
73  template <int dim, int spacedim = dim>
75  {
76  private:
78  std::vector<std::shared_ptr<FEValuesBase<dim, spacedim> > > fevalv;
79  public:
80  static const unsigned int dimension = dim;
81  static const unsigned int space_dimension = spacedim;
82 
87 
92 
111  template <class FEVALUES>
113  const Mapping<dim,spacedim> &mapping,
115  const UpdateFlags flags,
116  const BlockInfo *local_block_info = nullptr);
117 
121  void initialize_data(const std::shared_ptr<VectorDataBase<dim,spacedim> > &data);
122 
126  void clear();
127 
133 
135  bool multigrid;
137 
142  const FEValuesBase<dim, spacedim> &fe_values () const;
143 
145 
149  const FEValuesBase<dim, spacedim> &fe_values (const unsigned int i) const;
150 
159  std::vector<std::vector<std::vector<double> > > values;
160 
169  std::vector<std::vector<std::vector<Tensor<1,spacedim> > > > gradients;
170 
179  std::vector<std::vector<std::vector<Tensor<2,spacedim> > > > hessians;
180 
184  template <typename number>
185  void reinit(const DoFInfo<dim, spacedim, number> &i);
186 
191  template <typename number>
192  void fill_local_data(const DoFInfo<dim, spacedim, number> &info, bool split_fevalues);
193 
198  std::shared_ptr<VectorDataBase<dim, spacedim> > global_data;
199 
203  std::size_t memory_consumption () const;
204 
205  private:
210 
216  template <typename TYPE>
217  void fill_local_data(
218  std::vector<std::vector<std::vector<TYPE> > > &data,
219  VectorSelector &selector,
220  bool split_fevalues) const;
224  unsigned int n_components;
225  };
226 
281  template <int dim, int spacedim=dim>
283  {
284  public:
285 
290 
295 
304  const Mapping<dim, spacedim> &mapping,
305  const BlockInfo *block_info = nullptr);
306 
314  template <typename VectorType>
316  const Mapping<dim, spacedim> &mapping,
317  const AnyData &data,
318  const VectorType &dummy,
319  const BlockInfo *block_info = nullptr);
327  template <typename VectorType>
329  const Mapping<dim, spacedim> &mapping,
330  const AnyData &data,
331  const MGLevelObject<VectorType> &dummy,
332  const BlockInfo *block_info = nullptr);
336  /* @{ */
337 
348  void initialize_update_flags(bool neighbor_geometry = false);
349 
354  void add_update_flags_all (const UpdateFlags flags);
355 
359  void add_update_flags_cell(const UpdateFlags flags);
360 
364  void add_update_flags_boundary(const UpdateFlags flags);
365 
369  void add_update_flags_face(const UpdateFlags flags);
370 
377  void add_update_flags(const UpdateFlags flags,
378  const bool cell = true,
379  const bool boundary = true,
380  const bool face = true,
381  const bool neighbor = true);
382 
392  void initialize_gauss_quadrature(unsigned int n_cell_points,
393  unsigned int n_boundary_points,
394  unsigned int n_face_points,
395  const bool force = true);
396 
400  std::size_t memory_consumption () const;
401 
414 
421 
429 
434 
439 
444  /* @} */
445 
449  /* @{ */
450 
465 
471 
477 
478  std::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim> > cell_data;
479  std::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim> > boundary_data;
480  std::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim> > face_data;
481  /* @} */
482 
486  /* @{ */
504  template <class DOFINFO>
505  void post_cell(const DoFInfoBox<dim, DOFINFO> &);
506 
523  template <class DOFINFO>
524  void post_faces(const DoFInfoBox<dim, DOFINFO> &);
525 
547 
548  /* @} */
549  };
550 
551 
552 //----------------------------------------------------------------------//
553 
554  template <int dim, int sdim>
555  inline
557  :
558  fevalv(0),
559  multigrid(false),
560  global_data(std::make_shared<VectorDataBase<dim, sdim> >()),
561  n_components(numbers::invalid_unsigned_int)
562  {}
563 
564 
565  template <int dim, int sdim>
566  inline
568  :
569  multigrid(other.multigrid),
570  values(other.values),
571  gradients(other.gradients),
572  hessians(other.hessians),
573  global_data(other.global_data),
574  fe_pointer(other.fe_pointer),
575  n_components(other.n_components)
576  {
577  fevalv.resize(other.fevalv.size());
578  for (unsigned int i=0; i<other.fevalv.size(); ++i)
579  {
580  const FEValuesBase<dim,sdim> &p = *other.fevalv[i];
581  const FEValues<dim,sdim> *pc = dynamic_cast<const FEValues<dim,sdim>*>(&p);
582  const FEFaceValues<dim,sdim> *pf = dynamic_cast<const FEFaceValues<dim,sdim>*>(&p);
583  const FESubfaceValues<dim,sdim> *ps = dynamic_cast<const FESubfaceValues<dim,sdim>*>(&p);
584 
585  if (pc != nullptr)
586  fevalv[i] = std::make_shared<FEValues<dim,sdim> >
587  (pc->get_mapping(), pc->get_fe(),
588  pc->get_quadrature(), pc->get_update_flags());
589  else if (pf != nullptr)
590  fevalv[i] = std::make_shared<FEFaceValues<dim,sdim> >
591  (pf->get_mapping(), pf->get_fe(), pf->get_quadrature(), pf->get_update_flags());
592  else if (ps != nullptr)
593  fevalv[i] = std::make_shared<FESubfaceValues<dim,sdim> >
594  (ps->get_mapping(), ps->get_fe(), ps->get_quadrature(), ps->get_update_flags());
595  else
596  Assert(false, ExcInternalError());
597  }
598  }
599 
600 
601 
602  template <int dim, int sdim>
603  template <class FEVALUES>
604  inline void
606  const FiniteElement<dim,sdim> &el,
607  const Mapping<dim,sdim> &mapping,
609  const UpdateFlags flags,
610  const BlockInfo *block_info)
611  {
612  fe_pointer = &el;
613  if (block_info == nullptr || block_info->local().size() == 0)
614  {
615  fevalv.resize(1);
616  fevalv[0] = std::make_shared<FEVALUES>(mapping, el, quadrature, flags);
617  }
618  else
619  {
620  fevalv.resize(el.n_base_elements());
621  for (unsigned int i=0; i<fevalv.size(); ++i)
622  fevalv[i] = std::make_shared<FEVALUES> (mapping, el.base_element(i), quadrature, flags);
623  }
624  n_components = el.n_components();
625  }
626 
627 
628  template <int dim, int spacedim>
629  inline const FiniteElement<dim, spacedim> &
631  {
632  Assert (fe_pointer != nullptr, ExcNotInitialized());
633  return *fe_pointer;
634  }
635 
636  template <int dim, int spacedim>
637  inline const FEValuesBase<dim, spacedim> &
639  {
640  AssertDimension(fevalv.size(), 1);
641  return *fevalv[0];
642  }
643 
644 
645  template <int dim, int spacedim>
646  inline const FEValuesBase<dim, spacedim> &
648  {
649  Assert (i<fevalv.size(), ExcIndexRange(i,0,fevalv.size()));
650  return *fevalv[i];
651  }
652 
653 
654  template <int dim, int spacedim>
655  template <typename number>
656  inline void
658  {
659  for (unsigned int i=0; i<fevalv.size(); ++i)
660  {
661  FEValuesBase<dim, spacedim> &febase = *fevalv[i];
663  {
664  // This is a subface
665  FESubfaceValues<dim,spacedim> &fe = dynamic_cast<FESubfaceValues<dim,spacedim>&> (febase);
666  fe.reinit(info.cell, info.face_number, info.sub_number);
667  }
669  {
670  // This is a face
671  FEFaceValues<dim,spacedim> &fe = dynamic_cast<FEFaceValues<dim,spacedim>&> (febase);
672  fe.reinit(info.cell, info.face_number);
673  }
674  else
675  {
676  // This is a cell
677  FEValues<dim,spacedim> &fe = dynamic_cast<FEValues<dim,spacedim>&> (febase);
678  fe.reinit(info.cell);
679  }
680  }
681 
682  const bool split_fevalues = info.block_info != nullptr;
683  if (!global_data->empty())
684  fill_local_data(info, split_fevalues);
685  }
686 
687 
688 
689 
690 //----------------------------------------------------------------------//
691 
692  template <int dim, int sdim>
693  inline
694  void
696  unsigned int cp,
697  unsigned int bp,
698  unsigned int fp,
699  bool force)
700  {
701  if (force || cell_quadrature.size() == 0)
702  cell_quadrature = QGauss<dim>(cp);
703  if (force || boundary_quadrature.size() == 0)
704  boundary_quadrature = QGauss<dim-1>(bp);
705  if (force || face_quadrature.size() == 0)
706  face_quadrature = QGauss<dim-1>(fp);
707  }
708 
709 
710  template <int dim, int sdim>
711  inline
712  void
714  {
715  add_update_flags(flags, true, true, true, true);
716  }
717 
718 
719  template <int dim, int sdim>
720  inline
721  void
723  {
724  add_update_flags(flags, true, false, false, false);
725  }
726 
727 
728  template <int dim, int sdim>
729  inline
730  void
732  {
733  add_update_flags(flags, false, true, false, false);
734  }
735 
736 
737  template <int dim, int sdim>
738  inline
739  void
741  {
742  add_update_flags(flags, false, false, true, true);
743  }
744 
745 
746  template <int dim, int sdim>
747  inline
748  void
750  const FiniteElement<dim,sdim> &el,
751  const Mapping<dim,sdim> &mapping,
752  const BlockInfo *block_info)
753  {
754  initialize_update_flags();
755  initialize_gauss_quadrature(
756  (cell_flags & update_values) ? (el.tensor_degree()+1) : el.tensor_degree(),
757  (boundary_flags & update_values) ? (el.tensor_degree()+1) : el.tensor_degree(),
758  (face_flags & update_values) ? (el.tensor_degree()+1) : el.tensor_degree(), false);
759 
760  cell.template initialize<FEValues<dim,sdim> >(el, mapping, cell_quadrature,
761  cell_flags, block_info);
762  boundary.template initialize<FEFaceValues<dim,sdim> >(el, mapping, boundary_quadrature,
763  boundary_flags, block_info);
764  face.template initialize<FEFaceValues<dim,sdim> >(el, mapping, face_quadrature,
765  face_flags, block_info);
766  subface.template initialize<FESubfaceValues<dim,sdim> >(el, mapping, face_quadrature,
767  face_flags, block_info);
768  neighbor.template initialize<FEFaceValues<dim,sdim> >(el, mapping, face_quadrature,
769  neighbor_flags, block_info);
770  }
771 
772 
773  template <int dim, int sdim>
774  template <typename VectorType>
775  void
778  const Mapping<dim,sdim> &mapping,
779  const AnyData &data,
780  const VectorType &,
781  const BlockInfo *block_info)
782  {
783  initialize(el, mapping, block_info);
784  std::shared_ptr<VectorData<VectorType, dim, sdim> > p;
786 
787  p = std::make_shared<VectorData<VectorType, dim, sdim> > (cell_selector);
788  // Public member function of parent class was not found without
789  // explicit cast
790  pp = &*p;
791  pp->initialize(data);
792  cell_data = p;
793  cell.initialize_data(p);
794 
795  p = std::make_shared<VectorData<VectorType, dim, sdim> > (boundary_selector);
796  pp = &*p;
797  pp->initialize(data);
798  boundary_data = p;
799  boundary.initialize_data(p);
800 
801  p = std::make_shared<VectorData<VectorType, dim, sdim> > (face_selector);
802  pp = &*p;
803  pp->initialize(data);
804  face_data = p;
805  face.initialize_data(p);
806  subface.initialize_data(p);
807  neighbor.initialize_data(p);
808  }
809 
810  template <int dim, int sdim>
811  template <typename VectorType>
812  void
815  const Mapping<dim,sdim> &mapping,
816  const AnyData &data,
818  const BlockInfo *block_info)
819  {
820  initialize(el, mapping, block_info);
821  std::shared_ptr<MGVectorData<VectorType, dim, sdim> > p;
823 
824  p = std::make_shared<MGVectorData<VectorType, dim, sdim> > (cell_selector);
825  // Public member function of parent class was not found without
826  // explicit cast
827  pp = &*p;
828  pp->initialize(data);
829  cell_data = p;
830  cell.initialize_data(p);
831 
832  p = std::make_shared<MGVectorData<VectorType, dim, sdim> > (boundary_selector);
833  pp = &*p;
834  pp->initialize(data);
835  boundary_data = p;
836  boundary.initialize_data(p);
837 
838  p = std::make_shared<MGVectorData<VectorType, dim, sdim> > (face_selector);
839  pp = &*p;
840  pp->initialize(data);
841  face_data = p;
842  face.initialize_data(p);
843  subface.initialize_data(p);
844  neighbor.initialize_data(p);
845  }
846 
847  template <int dim, int sdim>
848  template <class DOFINFO>
849  void
851  {}
852 
853 
854  template <int dim, int sdim>
855  template <class DOFINFO>
856  void
858  {}
859 
860 
861 }
862 
863 DEAL_II_NAMESPACE_CLOSE
864 
865 #endif
Shape function values.
std::vector< std::vector< std::vector< double > > > values
Triangulation< dim, spacedim >::cell_iterator cell
The current cell.
Definition: dof_info.h:73
static const unsigned int invalid_unsigned_int
Definition: types.h:173
void initialize(const FiniteElement< dim, spacedim > &el, const Mapping< dim, spacedim > &mapping, const Quadrature< FEVALUES::integral_dimension > &quadrature, const UpdateFlags flags, const BlockInfo *local_block_info=nullptr)
#define AssertDimension(dim1, dim2)
Definition: exceptions.h:1248
void post_faces(const DoFInfoBox< dim, DOFINFO > &)
Quadrature< dim-1 > boundary_quadrature
void add_update_flags_cell(const UpdateFlags flags)
const FEValuesBase< dim, spacedim > & fe_values() const
Access to finite element.
const BlockIndices & local() const
Definition: block_info.h:217
std::shared_ptr< VectorDataBase< dim, spacedim > > global_data
std::size_t memory_consumption() const
std::vector< std::shared_ptr< FEValuesBase< dim, spacedim > > > fevalv
vector of FEValues objects
void add_update_flags_all(const UpdateFlags flags)
void fill_local_data(const DoFInfo< dim, spacedim, number > &info, bool split_fevalues)
const FiniteElement< dim, spacedim > & get_fe() const
UpdateFlags get_update_flags() const
STL namespace.
unsigned int sub_number
Definition: dof_info.h:92
static ::ExceptionBase & ExcNotInitialized()
std::vector< std::vector< std::vector< Tensor< 2, spacedim > > > > hessians
void initialize_update_flags(bool neighbor_geometry=false)
static ::ExceptionBase & ExcIndexRange(int arg1, int arg2, int arg3)
void add_update_flags_face(const UpdateFlags flags)
const Mapping< dim, spacedim > & get_mapping() const
void reinit(const TriaIterator< DoFCellAccessor< DoFHandlerType< dim, spacedim >, level_dof_access > > &cell, const unsigned int face_no, const unsigned int subface_no)
Definition: fe_values.cc:4466
const FiniteElement< dim, spacedim > & finite_element() const
void reinit(const DoFInfo< dim, spacedim, number > &i)
void initialize_gauss_quadrature(unsigned int n_cell_points, unsigned int n_boundary_points, unsigned int n_face_points, const bool force=true)
Quadrature< dim-1 > face_quadrature
std::size_t memory_consumption() const
std::vector< std::vector< std::vector< Tensor< 1, spacedim > > > > gradients
MeshWorker::VectorSelector cell_selector
void initialize(const FiniteElement< dim, spacedim > &el, const Mapping< dim, spacedim > &mapping, const BlockInfo *block_info=nullptr)
#define Assert(cond, exc)
Definition: exceptions.h:1142
UpdateFlags
void post_cell(const DoFInfoBox< dim, DOFINFO > &)
void reinit(const TriaIterator< DoFCellAccessor< DoFHandlerType< dim, spacedim >, level_dof_access > > &cell, const unsigned int face_no)
Definition: fe_values.cc:4303
Abstract base class for mapping classes.
Definition: dof_tools.h:46
const Quadrature< dim-1 > & get_quadrature() const
SmartPointer< const BlockInfo, DoFInfo< dim, spacedim > > block_info
The block structure of the system.
Definition: dof_info.h:161
virtual const FiniteElement< dim, spacedim > & base_element(const unsigned int index) const
Definition: fe.cc:1242
void add_update_flags_boundary(const UpdateFlags flags)
const Quadrature< dim > & get_quadrature() const
MeshWorker::VectorSelector boundary_selector
bool multigrid
This is true if we are assembling for multigrid.
unsigned int n_components() const
void add_update_flags(const UpdateFlags flags, const bool cell=true, const bool boundary=true, const bool face=true, const bool neighbor=true)
Definition: fe.h:33
unsigned int face_number
Definition: dof_info.h:84
A small class collecting the different BlockIndices involved in global, multilevel and local computat...
Definition: block_info.h:93
IntegrationInfo< dim, spacedim > CellInfo
SmartPointer< const FiniteElement< dim, spacedim >, IntegrationInfo< dim, spacedim > > fe_pointer
unsigned int n_base_elements() const
Definition: fe.h:3046
unsigned int size() const
void initialize(const AnyData &)
void reinit(const TriaIterator< DoFCellAccessor< DoFHandlerType< dim, spacedim >, level_dof_access > > &cell)
Definition: fe_values.cc:4106
void initialize_data(const std::shared_ptr< VectorDataBase< dim, spacedim > > &data)
MeshWorker::VectorSelector face_selector
unsigned int tensor_degree() const
static ::ExceptionBase & ExcInternalError()