namespace VectorTools
{
/**
- * Namespace for the flags for evaluate_at_points().
+ * Namespace for the flags for point_values().
*/
namespace EvaluationFlags
{
/**
- * Flags for evaluate_at_points().
+ * Flags for point_values().
*/
enum EvaluationFlags
{
*/
template <int n_components, int dim, int spacedim, typename VectorType>
std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
- evaluate_at_points(
+ 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>
std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
- evaluate_at_points(
+ point_values(
const Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
const DoFHandler<dim, spacedim> & dof_handler,
const VectorType & vector,
#ifndef DOXYGEN
template <int n_components, int dim, int spacedim, typename VectorType>
inline std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
- evaluate_at_points(
- const Mapping<dim> & mapping,
- const DoFHandler<dim, spacedim> & dof_handler,
- const VectorType & vector,
- const std::vector<Point<spacedim>> & evaluation_points,
- Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
- const EvaluationFlags::EvaluationFlags flags)
+ point_values(const Mapping<dim> & mapping,
+ const DoFHandler<dim, spacedim> & dof_handler,
+ const VectorType & vector,
+ const std::vector<Point<spacedim>> &evaluation_points,
+ Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
+ const EvaluationFlags::EvaluationFlags flags)
{
cache.reinit(evaluation_points, dof_handler.get_triangulation(), mapping);
- return evaluate_at_points<n_components>(cache, dof_handler, vector, flags);
+ return point_values<n_components>(cache, dof_handler, vector, flags);
}
template <int n_components, int dim, int spacedim, typename VectorType>
inline std::vector<typename FEPointEvaluation<n_components, dim>::value_type>
- evaluate_at_points(
+ point_values(
const Utilities::MPI::RemotePointEvaluation<dim, spacedim> &cache,
const DoFHandler<dim, spacedim> & dof_handler,
const VectorType & vector,
ExcMessage(
"Utilities::MPI::RemotePointEvaluation is not ready yet! "
"Please call Utilities::MPI::RemotePointEvaluation::reinit() "
- "yourself or the other evaluate_at_points(), which does this for"
+ "yourself or the other point_values(), which does this for"
"you."));
Assert(
Utilities::MPI::RemotePointEvaluation<dim> eval(1e-6, enforce_unique_map);
const auto result_avg =
- VectorTools::evaluate_at_points<1>(mapping,
- dof_handler,
- vec,
- evaluation_points,
- eval,
- VectorTools::EvaluationFlags::avg);
- const auto result_min = VectorTools::evaluate_at_points<1>(
+ VectorTools::point_values<1>(mapping,
+ dof_handler,
+ vec,
+ evaluation_points,
+ eval,
+ VectorTools::EvaluationFlags::avg);
+ const auto result_min = VectorTools::point_values<1>(
eval, dof_handler, vec, VectorTools::EvaluationFlags::min);
- const auto result_max = VectorTools::evaluate_at_points<1>(
+ const auto result_max = VectorTools::point_values<1>(
eval, dof_handler, vec, VectorTools::EvaluationFlags::max);
- const auto result_insert = VectorTools::evaluate_at_points<1>(
+ const auto result_insert = VectorTools::point_values<1>(
eval, dof_handler, vec, VectorTools::EvaluationFlags::insert);
for (unsigned int i = 0; i < evaluation_points.size(); ++i)