SET(_src
dof_info.cc
- evaluation_selector.cc
evaluation_template_factory.cc
evaluation_template_factory_inst2.cc
evaluation_template_factory_inst3.cc
)
SET(_inst
- evaluation_selector.inst.in
evaluation_template_factory.inst.in
mapping_info.inst.in
matrix_free.inst.in
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2017 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-
-#include <deal.II/matrix_free/evaluation_selector.h>
-
-DEAL_II_NAMESPACE_OPEN
-
-#include "evaluation_selector.inst"
-
-DEAL_II_NAMESPACE_CLOSE
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2017 - 2018 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-
-for (deal_II_dimension : DIMENSIONS; scalar_type : REAL_SCALARS)
- {
- template void
- SelectEvaluator<deal_II_dimension, -1, 0, VectorizedArray<scalar_type>>::
- integrate(const unsigned int,
- const EvaluationFlags::EvaluationFlags,
- const internal::MatrixFreeFunctions::ShapeInfo<
- VectorizedArray<scalar_type>> &shape_info,
- VectorizedArray<scalar_type> *,
- VectorizedArray<scalar_type> *,
- VectorizedArray<scalar_type> *,
- VectorizedArray<scalar_type> *,
- const bool);
-
- template void
- SelectEvaluator<deal_II_dimension, -1, 0, VectorizedArray<scalar_type>>::
- evaluate(const unsigned int,
- const EvaluationFlags::EvaluationFlags,
- const internal::MatrixFreeFunctions::ShapeInfo<
- VectorizedArray<scalar_type>> &shape_info,
- VectorizedArray<scalar_type> *,
- VectorizedArray<scalar_type> *,
- VectorizedArray<scalar_type> *,
- VectorizedArray<scalar_type> *,
- VectorizedArray<scalar_type> *);
- }
vector_tools_interpolate.cc
vector_tools_point_value.cc
vector_tools_project.cc
- vector_tools_project_inst2.cc
- vector_tools_project_inst3.cc
vector_tools_project_hp.cc
vector_tools_project_codim.cc
vector_tools_project_qp.cc
DEAL_II_NAMESPACE_OPEN
// ---------------------------- explicit instantiations --------------------
-#define SPLIT_INSTANTIATIONS_COUNT 3
-#ifndef SPLIT_INSTANTIATIONS_INDEX
-# define SPLIT_INSTANTIATIONS_INDEX 0
-#endif
#include "vector_tools_project.inst"
DEAL_II_NAMESPACE_CLOSE
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2017 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-
-#define SPLIT_INSTANTIATIONS_INDEX 1
-#include "vector_tools_project.cc"
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2017 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-
-#define SPLIT_INSTANTIATIONS_INDEX 2
-#include "vector_tools_project.cc"