unsigned int
n_dofs_for_dof_handler () const = 0;
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const Vector<double> &in,
- Vector<double> &out) const = 0;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const Vector<float> &in,
- Vector<float> &out) const = 0;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const Vector<long double> &in,
- Vector<long double> &out) const = 0;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const BlockVector<double> &in,
- Vector<double> &out) const = 0;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const BlockVector<float> &in,
- Vector<float> &out) const = 0;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const BlockVector<long double> &in,
- Vector<long double> &out) const = 0;
-
-#ifdef DEAL_II_USE_PETSC
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const PETScWrappers::Vector &in,
- Vector<PetscScalar> &out) const = 0;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const PETScWrappers::BlockVector &in,
- Vector<PetscScalar> &out) const = 0;
-#endif
-
-#ifdef DEAL_II_USE_TRILINOS
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::Vector &in,
- Vector<TrilinosScalar> &out) const = 0;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::BlockVector &in,
- Vector<TrilinosScalar> &out) const = 0;
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
-
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::MPI::Vector &in,
- Vector<TrilinosScalar> &out) const = 0;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::MPI::BlockVector &in,
- Vector<TrilinosScalar> &out) const = 0;
-#endif
+#include "fe_values.decl.1.inst"
};
unsigned int
n_dofs_for_dof_handler () const;
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const Vector<double> &in,
- Vector<double> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const Vector<float> &in,
- Vector<float> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const Vector<long double> &in,
- Vector<long double> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const BlockVector<double> &in,
- Vector<double> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const BlockVector<float> &in,
- Vector<float> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const BlockVector<long double> &in,
- Vector<long double> &out) const;
-
-#ifdef DEAL_II_USE_PETSC
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const PETScWrappers::Vector &in,
- Vector<PetscScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const PETScWrappers::BlockVector &in,
- Vector<PetscScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const PETScWrappers::MPI::Vector &in,
- Vector<PetscScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const PETScWrappers::MPI::BlockVector &in,
- Vector<PetscScalar> &out) const;
-#endif
-
-#ifdef DEAL_II_USE_TRILINOS
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::Vector &in,
- Vector<TrilinosScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::BlockVector &in,
- Vector<TrilinosScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::MPI::Vector &in,
- Vector<TrilinosScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::MPI::BlockVector &in,
- Vector<TrilinosScalar> &out) const;
-#endif
+#include "fe_values.decl.2.inst"
private:
/**
unsigned int
n_dofs_for_dof_handler () const;
- /**
- * Implement the respective
- * function of the base
- * class. Since this is not
- * possible, we just raise an
- * error.
- */
- virtual
- void
- get_interpolated_dof_values (const Vector<double> &in,
- Vector<double> &out) const;
-
- /**
- * Implement the respective
- * function of the base
- * class. Since this is not
- * possible, we just raise an
- * error.
- */
- virtual
- void
- get_interpolated_dof_values (const Vector<float> &in,
- Vector<float> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const Vector<long double> &in,
- Vector<long double> &out) const;
-
- /**
- * Implement the respective
- * function of the base
- * class. Since this is not
- * possible, we just raise an
- * error.
- */
- virtual
- void
- get_interpolated_dof_values (const BlockVector<double> &in,
- Vector<double> &out) const;
-
- /**
- * Implement the respective
- * function of the base
- * class. Since this is not
- * possible, we just raise an
- * error.
- */
- virtual
- void
- get_interpolated_dof_values (const BlockVector<float> &in,
- Vector<float> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const BlockVector<long double> &in,
- Vector<long double> &out) const;
-
-#ifdef DEAL_II_USE_PETSC
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const PETScWrappers::Vector &in,
- Vector<PetscScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const PETScWrappers::BlockVector &in,
- Vector<PetscScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const PETScWrappers::MPI::Vector &in,
- Vector<PetscScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const PETScWrappers::MPI::BlockVector &in,
- Vector<PetscScalar> &out) const;
-#endif
-
-#ifdef DEAL_II_USE_TRILINOS
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::Vector &in,
- Vector<TrilinosScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::BlockVector &in,
- Vector<TrilinosScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::MPI::Vector &in,
- Vector<TrilinosScalar> &out) const;
-
- /**
- * Call
- * @p get_interpolated_dof_values
- * of the iterator with the
- * given arguments.
- */
- virtual
- void
- get_interpolated_dof_values (const TrilinosWrappers::MPI::BlockVector &in,
- Vector<TrilinosScalar> &out) const;
-#endif
+#include "fe_values.decl.2.inst"
private:
/**
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const Vector<double> &in,
- Vector<double> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const Vector<float> &in,
- Vector<float> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const Vector<long double> &in,
- Vector<long double> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const BlockVector<double> &in,
- Vector<double> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const BlockVector<float> &in,
- Vector<float> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const BlockVector<long double> &in,
- Vector<long double> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-
-#ifdef DEAL_II_USE_PETSC
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const PETScWrappers::Vector &in,
- Vector<PetscScalar> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const PETScWrappers::BlockVector &in,
- Vector<PetscScalar> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const PETScWrappers::MPI::Vector &in,
- Vector<PetscScalar> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const PETScWrappers::MPI::BlockVector &in,
- Vector<PetscScalar> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-#endif
-
-#ifdef DEAL_II_USE_TRILINOS
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const TrilinosWrappers::Vector &in,
- Vector<TrilinosScalar> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim,spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const TrilinosWrappers::BlockVector &in,
- Vector<TrilinosScalar> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim, spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const TrilinosWrappers::MPI::Vector &in,
- Vector<TrilinosScalar> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-
-
-template <int dim, int spacedim>
-template <typename CI>
-void
-FEValuesBase<dim, spacedim>::CellIterator<CI>::
-get_interpolated_dof_values (const TrilinosWrappers::MPI::BlockVector &in,
- Vector<TrilinosScalar> &out) const
-{
- cell->get_interpolated_dof_values (in, out);
-}
-
-#endif
+#include "fe_values.impl.inst"
/* ---------------- FEValuesBase<dim,spacedim>::TriaCellIterator --------- */
}
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const Vector<double> &,
- Vector<double> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const Vector<float> &,
- Vector<float> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const Vector<long double> &,
- Vector<long double> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const BlockVector<double> &,
- Vector<double> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const BlockVector<float> &,
- Vector<float> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const BlockVector<long double> &,
- Vector<long double> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-
-#ifdef DEAL_II_USE_PETSC
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const PETScWrappers::Vector &,
- Vector<PetscScalar> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const PETScWrappers::BlockVector &,
- Vector<PetscScalar> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const PETScWrappers::MPI::Vector &,
- Vector<PetscScalar> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const PETScWrappers::MPI::BlockVector &,
- Vector<PetscScalar> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-#endif
-
-#ifdef DEAL_II_USE_TRILINOS
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const TrilinosWrappers::Vector &,
- Vector<TrilinosScalar> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const TrilinosWrappers::BlockVector &,
- Vector<TrilinosScalar> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim, spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const TrilinosWrappers::MPI::Vector &,
- Vector<TrilinosScalar> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-
-
-template <int dim, int spacedim>
-void
-FEValuesBase<dim,spacedim>::TriaCellIterator::
-get_interpolated_dof_values (const TrilinosWrappers::MPI::BlockVector &,
- Vector<TrilinosScalar> &) const
-{
- Assert (false, ExcMessage (message_string));
-}
-
-#endif
-
+#include "fe_values.impl.2.inst"