* processors in the communicator.
*/
template <int n_components, int dim, int spacedim, typename VectorType>
- std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
+ std::vector<
+ typename FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>::value_type>
point_values(
const Mapping<dim> & mapping,
const DoFHandler<dim, spacedim> & dof_handler,
* processors in the communicator.
*/
template <int n_components, int dim, int spacedim, typename VectorType>
- std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
+ std::vector<
+ typename FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>::value_type>
point_values(
const Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
const DoFHandler<dim, spacedim> & dof_handler,
* processors in the communicator.
*/
template <int n_components, int dim, int spacedim, typename VectorType>
- std::vector<typename FEPointEvaluation<n_components, dim>::gradient_type>
+ std::vector<
+ typename FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>::gradient_type>
point_gradients(
const Mapping<dim> & mapping,
const DoFHandler<dim, spacedim> & dof_handler,
* processors in the communicator.
*/
template <int n_components, int dim, int spacedim, typename VectorType>
- std::vector<typename FEPointEvaluation<n_components, dim>::gradient_type>
+ std::vector<
+ typename FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>::gradient_type>
point_gradients(
const Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
const DoFHandler<dim, spacedim> & dof_handler,
#ifndef DOXYGEN
template <int n_components, int dim, int spacedim, typename VectorType>
- inline std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
+ inline std::vector<
+ typename FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>::value_type>
point_values(const Mapping<dim> & mapping,
const DoFHandler<dim, spacedim> & dof_handler,
const VectorType & vector,
template <int n_components, int dim, int spacedim, typename VectorType>
inline std::vector<
- typename FEPointEvaluation<n_components, dim>::gradient_type>
+ typename FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>::gradient_type>
point_gradients(const Mapping<dim> & mapping,
const DoFHandler<dim, spacedim> & dof_handler,
const VectorType & vector,
const UpdateFlags update_flags,
const dealii::EvaluationFlags::EvaluationFlags evaluation_flags,
const std::function<
- value_type(const FEPointEvaluation<n_components, dim> &,
+ value_type(const FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type> &,
const unsigned int &)> process_quadrature_point)
{
Assert(cache.is_ready(),
const auto &cell_data) {
std::vector<typename VectorType::value_type> solution_values;
- std::vector<std::unique_ptr<FEPointEvaluation<n_components, dim>>>
+ std::vector<
+ std::unique_ptr<FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>>>
evaluators(dof_handler.get_fe_collection().size());
for (unsigned int i = 0; i < cell_data.cells.size(); ++i)
solution_values.end());
if (evaluators[cell->active_fe_index()] == nullptr)
- evaluators[cell->active_fe_index()] =
- std::make_unique<FEPointEvaluation<n_components, dim>>(
- cache.get_mapping(), cell->get_fe(), update_flags);
+ evaluators[cell->active_fe_index()] = std::make_unique<
+ FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>>(
+ cache.get_mapping(), cell->get_fe(), update_flags);
auto &evaluator = *evaluators[cell->active_fe_index()];
evaluator.reinit(cell, unit_points);
} // namespace internal
template <int n_components, int dim, int spacedim, typename VectorType>
- inline std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
+ inline std::vector<
+ typename FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>::value_type>
point_values(
const Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
const DoFHandler<dim, spacedim> & dof_handler,
dim,
spacedim,
VectorType,
- typename FEPointEvaluation<n_components, dim>::value_type>(
+ typename FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>::value_type>(
cache,
dof_handler,
vector,
template <int n_components, int dim, int spacedim, typename VectorType>
inline std::vector<
- typename FEPointEvaluation<n_components, dim>::gradient_type>
+ typename FEPointEvaluation<n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>::gradient_type>
point_gradients(
const Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
const DoFHandler<dim, spacedim> & dof_handler,
dim,
spacedim,
VectorType,
- typename FEPointEvaluation<n_components, dim>::gradient_type>(
+ typename FEPointEvaluation<
+ n_components,
+ dim,
+ spacedim,
+ typename VectorType::value_type>::gradient_type>(
cache,
dof_handler,
vector,