vector_tools_point_value.cc
vector_tools_point_gradient.cc
vector_tools_project.cc
+ vector_tools_project_qp.cc
+ vector_tools_project_qpmf.cc
vector_tools_rhs.cc
)
vector_tools_point_value.inst.in
vector_tools_point_gradient.inst.in
vector_tools_project.inst.in
+ vector_tools_project_qp.inst.in
+ vector_tools_project_qpmf.inst.in
vector_tools_rhs.inst.in
)
\}
#endif
}
-
-for (VEC: REAL_NONBLOCK_VECTORS; deal_II_dimension : DIMENSIONS)
-{
- namespace VectorTools \{
-
- template
- void project<deal_II_dimension,VEC,deal_II_dimension>(
- const Mapping<deal_II_dimension, deal_II_dimension> &,
- const DoFHandler<deal_II_dimension,deal_II_dimension> &,
- const ConstraintMatrix &,
- const Quadrature<deal_II_dimension> &,
- const std_cxx11::function<VEC::value_type (const DoFHandler<deal_II_dimension, deal_II_dimension>::active_cell_iterator &, const unsigned int)>,
- VEC &);
-
- template
- void project<deal_II_dimension, VEC>(
- const MatrixFree<deal_II_dimension,VEC::value_type> &matrix_free,
- const ConstraintMatrix &constraints,
- const std_cxx11::function< VectorizedArray<VEC::value_type> (const unsigned int, const unsigned int)>,
- VEC &);
-
- template
- void project<deal_II_dimension, VEC>(
- const MatrixFree<deal_II_dimension,VEC::value_type> &matrix_free,
- const ConstraintMatrix &constraints,
- const unsigned int,
- const std_cxx11::function< VectorizedArray<VEC::value_type> (const unsigned int, const unsigned int)>,
- VEC &);
-
- \}
-
-}
-
--- /dev/null
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2016 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 at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+#include <deal.II/numerics/vector_tools.templates.h>
+
+DEAL_II_NAMESPACE_OPEN
+
+// ---------------------------- explicit instantiations --------------------
+#include "vector_tools_project_qp.inst"
+
+DEAL_II_NAMESPACE_CLOSE
--- /dev/null
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2016 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 at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+for (VEC: REAL_NONBLOCK_VECTORS; deal_II_dimension : DIMENSIONS)
+{
+ namespace VectorTools \{
+
+ template
+ void project<deal_II_dimension,VEC,deal_II_dimension>(
+ const Mapping<deal_II_dimension, deal_II_dimension> &,
+ const DoFHandler<deal_II_dimension,deal_II_dimension> &,
+ const ConstraintMatrix &,
+ const Quadrature<deal_II_dimension> &,
+ const std_cxx11::function<VEC::value_type (const DoFHandler<deal_II_dimension, deal_II_dimension>::active_cell_iterator &, const unsigned int)>,
+ VEC &);
+
+ \}
+
+}
--- /dev/null
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2016 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 at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+#include <deal.II/numerics/vector_tools.templates.h>
+
+DEAL_II_NAMESPACE_OPEN
+
+// ---------------------------- explicit instantiations --------------------
+#include "vector_tools_project_qpmf.inst"
+
+DEAL_II_NAMESPACE_CLOSE
--- /dev/null
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2016 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 at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+
+for (VEC: REAL_NONBLOCK_VECTORS; deal_II_dimension : DIMENSIONS)
+{
+ namespace VectorTools \{
+
+ template
+ void project<deal_II_dimension, VEC>(
+ const MatrixFree<deal_II_dimension,VEC::value_type> &matrix_free,
+ const ConstraintMatrix &constraints,
+ const std_cxx11::function< VectorizedArray<VEC::value_type> (const unsigned int, const unsigned int)>,
+ VEC &);
+
+ template
+ void project<deal_II_dimension, VEC>(
+ const MatrixFree<deal_II_dimension,VEC::value_type> &matrix_free,
+ const ConstraintMatrix &constraints,
+ const unsigned int,
+ const std_cxx11::function< VectorizedArray<VEC::value_type> (const unsigned int, const unsigned int)>,
+ VEC &);
+
+ \}
+
+}