From 8b0a65fcdd5d3c7709bd5c9ee969b116a699f7bb Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Sat, 6 Aug 2016 14:52:12 -0400 Subject: [PATCH] indent all files --- source/algorithms/operator.inst.in | 8 +- source/base/data_out_base.inst.in | 228 +-- source/base/function.inst.in | 28 +- source/base/function_time.inst.in | 4 +- source/base/mpi.inst.in | 112 +- .../base/polynomials_rannacher_turek.inst.in | 4 +- source/base/symmetric_tensor.inst.in | 16 +- source/base/tensor.inst.in | 16 +- source/base/tensor_function.inst.in | 12 +- source/base/time_stepping.inst.in | 32 +- source/distributed/grid_refinement.inst.in | 84 +- source/distributed/shared_tria.inst.in | 16 +- source/distributed/solution_transfer.inst.in | 10 +- source/distributed/tria.inst.in | 60 +- source/distributed/tria_base.inst.in | 10 +- source/dofs/block_info.inst.in | 4 +- source/dofs/dof_accessor.inst.in | 34 +- source/dofs/dof_accessor_get.inst.in | 56 +- source/dofs/dof_accessor_set.inst.in | 56 +- source/dofs/dof_handler.inst.in | 210 +-- source/dofs/dof_handler_policy.inst.in | 36 +- source/dofs/dof_objects.inst.in | 50 +- source/dofs/dof_renumbering.inst.in | 338 ++-- source/dofs/dof_tools.inst.in | 1472 ++++++++--------- source/dofs/dof_tools_constraints.inst.in | 188 +-- source/dofs/dof_tools_sparsity.inst.in | 60 +- source/fe/fe.inst.in | 4 +- source/fe/fe_abf.inst.in | 4 +- source/fe/fe_bdm.inst.in | 4 +- source/fe/fe_bernstein.inst.in | 10 +- source/fe/fe_dg_vector.inst.in | 6 +- source/fe/fe_dgp.inst.in | 6 +- source/fe/fe_dgp_monomial.inst.in | 4 +- source/fe/fe_dgp_nonparametric.inst.in | 4 +- source/fe/fe_dgq.inst.in | 4 +- source/fe/fe_face.inst.in | 4 +- source/fe/fe_nedelec.inst.in | 4 +- source/fe/fe_nothing.inst.in | 4 +- source/fe/fe_poly.inst.in | 4 +- source/fe/fe_poly_tensor.inst.in | 4 +- source/fe/fe_q.inst.in | 6 +- source/fe/fe_q_base.inst.in | 6 +- source/fe/fe_q_bubbles.inst.in | 4 +- source/fe/fe_q_dg0.inst.in | 6 +- source/fe/fe_q_hierarchical.inst.in | 4 +- source/fe/fe_q_iso_q1.inst.in | 6 +- source/fe/fe_rannacher_turek.inst.in | 4 +- source/fe/fe_raviart_thomas.inst.in | 4 +- source/fe/fe_raviart_thomas_nodal.inst.in | 4 +- source/fe/fe_system.inst.in | 8 +- source/fe/fe_tools.inst.in | 394 ++--- source/fe/fe_tools_interpolate.inst.in | 144 +- source/fe/fe_trace.inst.in | 4 +- source/fe/fe_values.decl.1.inst.in | 14 +- source/fe/fe_values.decl.2.inst.in | 14 +- source/fe/fe_values.impl.1.inst.in | 10 +- source/fe/fe_values.impl.2.inst.in | 10 +- source/fe/fe_values.inst.in | 542 +++--- source/fe/mapping.inst.in | 6 +- source/fe/mapping_c1.inst.in | 4 +- source/fe/mapping_cartesian.inst.in | 4 +- source/fe/mapping_fe_field.inst.in | 6 +- source/fe/mapping_manifold.inst.in | 6 +- source/fe/mapping_q.inst.in | 6 +- source/fe/mapping_q1.inst.in | 6 +- source/fe/mapping_q1_eulerian.inst.in | 6 +- source/fe/mapping_q_eulerian.inst.in | 6 +- source/fe/mapping_q_generic.inst.in | 6 +- source/grid/grid_generator.inst.in | 202 +-- source/grid/grid_in.inst.in | 4 +- source/grid/grid_out.inst.in | 114 +- source/grid/grid_refinement.inst.in | 176 +- source/grid/grid_tools.inst.in | 368 ++--- source/grid/intergrid_map.inst.in | 4 +- source/grid/manifold.inst.in | 4 +- source/grid/manifold_lib.inst.in | 8 +- source/grid/tria.inst.in | 4 +- source/grid/tria_accessor.inst.in | 4 +- source/grid/tria_boundary.inst.in | 6 +- source/grid/tria_boundary_lib.inst.in | 6 +- source/grid/tria_objects.inst.in | 4 +- source/hp/dof_handler.inst.in | 96 +- source/hp/fe_collection.inst.in | 6 +- source/hp/fe_values.inst.in | 84 +- source/hp/mapping_collection.inst.in | 6 +- source/lac/block_sparse_matrix.inst.in | 4 +- source/lac/block_vector.inst.in | 20 +- source/lac/chunk_sparse_matrix.inst.in | 124 +- source/lac/constraint_matrix.inst.in | 48 +- source/lac/full_matrix.inst.in | 252 +-- source/lac/la_parallel_block_vector.inst.in | 22 +- source/lac/la_parallel_vector.inst.in | 38 +- source/lac/la_vector.inst.in | 8 +- source/lac/lapack_full_matrix.inst.in | 8 +- source/lac/precondition_block.inst.in | 76 +- source/lac/read_write_vector.inst.in | 28 +- source/lac/relaxation_block.inst.in | 32 +- source/lac/solver.inst.in | 4 +- source/lac/sparse_matrix.inst.in | 324 ++-- source/lac/sparse_matrix_ez.inst.in | 50 +- source/lac/trilinos_sparse_matrix.inst.in | 56 +- source/lac/trilinos_vector_base.inst.in | 8 +- source/lac/vector.inst.in | 42 +- source/lac/vector_memory.inst.in | 10 +- source/lac/vector_view.inst.in | 8 +- source/matrix_free/matrix_free.inst.in | 36 +- source/meshworker/mesh_worker_info.inst.in | 30 +- .../mesh_worker_vector_selector.inst.in | 12 +- source/multigrid/mg_base.inst.in | 8 +- .../mg_level_global_transfer.inst.in | 58 +- source/multigrid/mg_tools.inst.in | 134 +- source/multigrid/mg_transfer_block.inst.in | 216 +-- .../multigrid/mg_transfer_component.inst.in | 156 +- .../multigrid/mg_transfer_matrix_free.inst.in | 4 +- source/multigrid/mg_transfer_prebuilt.inst.in | 10 +- source/multigrid/multigrid.inst.in | 2 +- source/numerics/data_out.inst.in | 20 +- source/numerics/data_out_dof_data.inst.in | 654 ++++---- source/numerics/data_out_faces.inst.in | 6 +- source/numerics/data_out_rotation.inst.in | 2 +- source/numerics/data_out_stack.inst.in | 64 +- source/numerics/data_postprocessor.inst.in | 6 +- .../numerics/derivative_approximation.inst.in | 218 +-- source/numerics/dof_output_operator.inst.in | 2 +- source/numerics/error_estimator.inst.in | 242 +-- source/numerics/error_estimator_1d.inst.in | 224 +-- source/numerics/fe_field_function.inst.in | 12 +- source/numerics/matrix_creator.inst.in | 672 ++++---- source/numerics/matrix_tools.inst.in | 56 +- source/numerics/point_value_history.inst.in | 50 +- source/numerics/time_dependent.inst.in | 14 +- source/numerics/vector_tools_boundary.inst.in | 310 ++-- .../numerics/vector_tools_constraints.inst.in | 128 +- .../vector_tools_integrate_difference.inst.in | 190 +-- .../numerics/vector_tools_interpolate.inst.in | 144 +- .../numerics/vector_tools_mean_value.inst.in | 40 +- .../vector_tools_point_gradient.inst.in | 88 +- .../numerics/vector_tools_point_value.inst.in | 244 +-- source/numerics/vector_tools_project.inst.in | 90 +- source/numerics/vector_tools_rhs.inst.in | 132 +- source/opencascade/boundary_lib.inst.in | 12 +- 141 files changed, 5497 insertions(+), 5497 deletions(-) diff --git a/source/algorithms/operator.inst.in b/source/algorithms/operator.inst.in index d0360045d8..1e7f0bd457 100644 --- a/source/algorithms/operator.inst.in +++ b/source/algorithms/operator.inst.in @@ -15,8 +15,8 @@ for (VEC : SERIAL_VECTORS) -{ - template class OutputOperator; - template class Newton; - template class ThetaTimestepping; +{ + template class OutputOperator; + template class Newton; + template class ThetaTimestepping; } diff --git a/source/base/data_out_base.inst.in b/source/base/data_out_base.inst.in index b3018500cc..b122aaff9f 100644 --- a/source/base/data_out_base.inst.in +++ b/source/base/data_out_base.inst.in @@ -17,126 +17,126 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { #if deal_II_dimension <= deal_II_space_dimension - template class DataOutInterface; - template class DataOutReader; - - namespace DataOutBase - \{ - template struct Patch; - - template - std::ostream & - operator << (std::ostream &out, - const Patch &patch); - - template - std::istream & - operator >> (std::istream &in, - Patch &patch); - - template - void - write_vtk (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const VtkFlags &flags, - std::ostream &out); - - template - void - write_vtu (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const VtkFlags &flags, - std::ostream &out); - - template - void - write_ucd (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const UcdFlags &flags, - std::ostream &out); - - template - void - write_dx (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const DXFlags &flags, - std::ostream &out); - - template - void - write_gnuplot (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const GnuplotFlags &flags, - std::ostream &out); - - template - void - write_povray (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const PovrayFlags &flags, - std::ostream &out); - - template - void - write_eps (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const EpsFlags &flags, - std::ostream &out); - - template - void - write_gmv (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const GmvFlags &flags, - std::ostream &out); - - template - void - write_tecplot (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const TecplotFlags &flags, - std::ostream &out); - - template - void - write_tecplot_binary (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const TecplotFlags &flags, - std::ostream &out); + template class DataOutInterface; + template class DataOutReader; + + namespace DataOutBase + \{ + template struct Patch; + + template + std::ostream & + operator << (std::ostream &out, + const Patch &patch); + + template + std::istream & + operator >> (std::istream &in, + Patch &patch); + + template + void + write_vtk (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const VtkFlags &flags, + std::ostream &out); + + template + void + write_vtu (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const VtkFlags &flags, + std::ostream &out); + + template + void + write_ucd (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const UcdFlags &flags, + std::ostream &out); + + template + void + write_dx (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const DXFlags &flags, + std::ostream &out); + + template + void + write_gnuplot (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const GnuplotFlags &flags, + std::ostream &out); + + template + void + write_povray (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const PovrayFlags &flags, + std::ostream &out); + + template + void + write_eps (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const EpsFlags &flags, + std::ostream &out); + + template + void + write_gmv (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const GmvFlags &flags, + std::ostream &out); + + template + void + write_tecplot (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const TecplotFlags &flags, + std::ostream &out); + + template + void + write_tecplot_binary (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const TecplotFlags &flags, + std::ostream &out); #if deal_II_space_dimension >1 - template - void - write_svg (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const SvgFlags &flags, - std::ostream &out); + template + void + write_svg (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const SvgFlags &flags, + std::ostream &out); #endif - template - void - write_deal_II_intermediate (const std::vector > &patches, - const std::vector &data_names, - const std::vector > &vector_data_ranges, - const Deal_II_IntermediateFlags &flags, - std::ostream &out); - \} + template + void + write_deal_II_intermediate (const std::vector > &patches, + const std::vector &data_names, + const std::vector > &vector_data_ranges, + const Deal_II_IntermediateFlags &flags, + std::ostream &out); + \} #endif } for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; flag_type : OUTPUT_FLAG_TYPES) { - template - void - DataOutInterface::set_flags (const DataOutBase::flag_type &flags); + template + void + DataOutInterface::set_flags (const DataOutBase::flag_type &flags); } diff --git a/source/base/function.inst.in b/source/base/function.inst.in index 26711a7ce4..489afac369 100644 --- a/source/base/function.inst.in +++ b/source/base/function.inst.in @@ -16,22 +16,22 @@ for (S : REAL_SCALARS; dim : SPACE_DIMENSIONS) { - template class Function; - template class ZeroFunction; - template class ConstantFunction; - template class ComponentSelectFunction; - template class ScalarFunctionFromFunctionObject; - template class VectorFunctionFromScalarFunctionObject; - template class VectorFunctionFromTensorFunction; + template class Function; + template class ZeroFunction; + template class ConstantFunction; + template class ComponentSelectFunction; + template class ScalarFunctionFromFunctionObject; + template class VectorFunctionFromScalarFunctionObject; + template class VectorFunctionFromTensorFunction; } for (S : COMPLEX_SCALARS; dim : SPACE_DIMENSIONS) { - template class Function; - template class ZeroFunction; - template class ConstantFunction; - template class ComponentSelectFunction; - template class ScalarFunctionFromFunctionObject; - template class VectorFunctionFromScalarFunctionObject; - template class VectorFunctionFromTensorFunction; + template class Function; + template class ZeroFunction; + template class ConstantFunction; + template class ComponentSelectFunction; + template class ScalarFunctionFromFunctionObject; + template class VectorFunctionFromScalarFunctionObject; + template class VectorFunctionFromTensorFunction; } diff --git a/source/base/function_time.inst.in b/source/base/function_time.inst.in index 56f36f192a..c27c9899c7 100644 --- a/source/base/function_time.inst.in +++ b/source/base/function_time.inst.in @@ -15,10 +15,10 @@ for (S : REAL_SCALARS) { - template class FunctionTime; + template class FunctionTime; } for (S : COMPLEX_SCALARS) { - template class FunctionTime; + template class FunctionTime; } diff --git a/source/base/mpi.inst.in b/source/base/mpi.inst.in index 760a28fdac..2420c84fea 100644 --- a/source/base/mpi.inst.in +++ b/source/base/mpi.inst.in @@ -16,79 +16,79 @@ for (S : MPI_SCALARS) { - template - void sum (const Vector &, const MPI_Comm &, Vector &); - - template - S sum (const S &, const MPI_Comm &); - - template - void sum (const std::vector &, const MPI_Comm &, std::vector &); - - template - S max (const S &, const MPI_Comm &); - - template - void max (const std::vector &, const MPI_Comm &, std::vector &); - - template - S min (const S &, const MPI_Comm &); - - template - void min (const std::vector &, const MPI_Comm &, std::vector &); - - // The fixed-length array (i.e., things declared like T(&values)[N]) - // versions of the functions above live in the header file mpi.h since the - // length (N) is a compile-time constant. Those functions all call - // Utilities::MPI::internal::all_reduce, which is declared in - // mpi.templates.h, so that function (all_reduce) must be present in the - // compiled library. - // - // Note for the curious: it turns out that most compilers and most compiler - // settings will not inline this function, meaning that it consistently - // shows up in the shared object files without this explicit instantiation - // in debug mode and usually in release mode. In particular, GCC 6 does not - // inline it (so this instantiation is not necessary) but clang 3.8 does (so - // this instantiation is necessary). Some versions of GCC (5.3 but not 4.8) - // seem to inline it with the '-march=native' flag. - template - void Utilities::MPI::internal::all_reduce (const MPI_Op &, - const S *const, - const MPI_Comm &, - S *, - const std::size_t); + template + void sum (const Vector &, const MPI_Comm &, Vector &); + + template + S sum (const S &, const MPI_Comm &); + + template + void sum (const std::vector &, const MPI_Comm &, std::vector &); + + template + S max (const S &, const MPI_Comm &); + + template + void max (const std::vector &, const MPI_Comm &, std::vector &); + + template + S min (const S &, const MPI_Comm &); + + template + void min (const std::vector &, const MPI_Comm &, std::vector &); + + // The fixed-length array (i.e., things declared like T(&values)[N]) + // versions of the functions above live in the header file mpi.h since the + // length (N) is a compile-time constant. Those functions all call + // Utilities::MPI::internal::all_reduce, which is declared in + // mpi.templates.h, so that function (all_reduce) must be present in the + // compiled library. + // + // Note for the curious: it turns out that most compilers and most compiler + // settings will not inline this function, meaning that it consistently + // shows up in the shared object files without this explicit instantiation + // in debug mode and usually in release mode. In particular, GCC 6 does not + // inline it (so this instantiation is not necessary) but clang 3.8 does (so + // this instantiation is necessary). Some versions of GCC (5.3 but not 4.8) + // seem to inline it with the '-march=native' flag. + template + void Utilities::MPI::internal::all_reduce (const MPI_Op &, + const S *const, + const MPI_Comm &, + S *, + const std::size_t); } for (S : COMPLEX_SCALARS) { - template - void sum (const Vector &, const MPI_Comm &, Vector &); + template + void sum (const Vector &, const MPI_Comm &, Vector &); - template - S sum (const S &, const MPI_Comm &); + template + S sum (const S &, const MPI_Comm &); - template - void sum (const std::vector &, const MPI_Comm &, std::vector &); + template + void sum (const std::vector &, const MPI_Comm &, std::vector &); } for (S : REAL_SCALARS; rank: RANKS; dim : SPACE_DIMENSIONS) { - template - Tensor - sum (const Tensor &, const MPI_Comm &); + template + Tensor + sum (const Tensor &, const MPI_Comm &); } // Recall that SymmetricTensor only makes sense for rank 2 and 4 for (S : REAL_SCALARS; dim : SPACE_DIMENSIONS) { - template - SymmetricTensor<2,dim,S> - sum<2,dim,S> (const SymmetricTensor<2,dim,S> &, const MPI_Comm &); + template + SymmetricTensor<2,dim,S> + sum<2,dim,S> (const SymmetricTensor<2,dim,S> &, const MPI_Comm &); - template - SymmetricTensor<4,dim,S> - sum<4,dim,S> (const SymmetricTensor<4,dim,S> &, const MPI_Comm &); + template + SymmetricTensor<4,dim,S> + sum<4,dim,S> (const SymmetricTensor<4,dim,S> &, const MPI_Comm &); } diff --git a/source/base/polynomials_rannacher_turek.inst.in b/source/base/polynomials_rannacher_turek.inst.in index 32c95b61bd..4409a42f59 100644 --- a/source/base/polynomials_rannacher_turek.inst.in +++ b/source/base/polynomials_rannacher_turek.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class PolynomialsRannacherTurek; - } +} diff --git a/source/base/symmetric_tensor.inst.in b/source/base/symmetric_tensor.inst.in index defcf42a00..e0b698fb7f 100644 --- a/source/base/symmetric_tensor.inst.in +++ b/source/base/symmetric_tensor.inst.in @@ -16,18 +16,18 @@ for (deal_II_dimension : DIMENSIONS; number : REAL_SCALARS) { - template - class SymmetricTensor<2,deal_II_dimension,number>; + template + class SymmetricTensor<2,deal_II_dimension,number>; - template - class SymmetricTensor<4,deal_II_dimension,number>; + template + class SymmetricTensor<4,deal_II_dimension,number>; } for (deal_II_dimension : DIMENSIONS; number : COMPLEX_SCALARS) { - template - class SymmetricTensor<2,deal_II_dimension,number>; + template + class SymmetricTensor<2,deal_II_dimension,number>; - template - class SymmetricTensor<4,deal_II_dimension,number>; + template + class SymmetricTensor<4,deal_II_dimension,number>; } diff --git a/source/base/tensor.inst.in b/source/base/tensor.inst.in index 9860554b47..18840ec4d7 100644 --- a/source/base/tensor.inst.in +++ b/source/base/tensor.inst.in @@ -16,27 +16,27 @@ for (rank : RANKS; deal_II_dimension : DIMENSIONS; number : REAL_SCALARS) { - template - class Tensor; + template + class Tensor; } for (deal_II_dimension : DIMENSIONS; number : REAL_SCALARS) { - template - class Tensor<0,deal_II_dimension,number>; + template + class Tensor<0,deal_II_dimension,number>; } for (rank : RANKS; deal_II_dimension : DIMENSIONS; number : COMPLEX_SCALARS) { - template - class Tensor; + template + class Tensor; } for (deal_II_dimension : DIMENSIONS; number : COMPLEX_SCALARS) { - template - class Tensor<0,deal_II_dimension,number>; + template + class Tensor<0,deal_II_dimension,number>; } diff --git a/source/base/tensor_function.inst.in b/source/base/tensor_function.inst.in index 39a52c9402..2c0186d375 100644 --- a/source/base/tensor_function.inst.in +++ b/source/base/tensor_function.inst.in @@ -16,14 +16,14 @@ for (S : REAL_SCALARS; rank: RANKS; dim : SPACE_DIMENSIONS) { - template class TensorFunction; - template class ConstantTensorFunction; - template class ZeroTensorFunction; + template class TensorFunction; + template class ConstantTensorFunction; + template class ZeroTensorFunction; } for (S : COMPLEX_SCALARS; rank: RANKS; dim : SPACE_DIMENSIONS) { - template class TensorFunction; - template class ConstantTensorFunction; - template class ZeroTensorFunction; + template class TensorFunction; + template class ConstantTensorFunction; + template class ZeroTensorFunction; } diff --git a/source/base/time_stepping.inst.in b/source/base/time_stepping.inst.in index f9da377ef9..bce77adf1b 100644 --- a/source/base/time_stepping.inst.in +++ b/source/base/time_stepping.inst.in @@ -16,32 +16,32 @@ for (S : REAL_SCALARS; V : DEAL_II_VEC_TEMPLATES) { - template class RungeKutta >; - template class ExplicitRungeKutta >; - template class ImplicitRungeKutta >; - template class EmbeddedExplicitRungeKutta >; + template class RungeKutta >; + template class ExplicitRungeKutta >; + template class ImplicitRungeKutta >; + template class EmbeddedExplicitRungeKutta >; } for (S : REAL_SCALARS; V : DEAL_II_VEC_TEMPLATES) { - template class RungeKutta >; - template class ExplicitRungeKutta >; - template class ImplicitRungeKutta >; - template class EmbeddedExplicitRungeKutta >; + template class RungeKutta >; + template class ExplicitRungeKutta >; + template class ImplicitRungeKutta >; + template class EmbeddedExplicitRungeKutta >; } for (V : EXTERNAL_SEQUENTIAL_VECTORS) { - template class RungeKutta; - template class ExplicitRungeKutta; - template class ImplicitRungeKutta; - template class EmbeddedExplicitRungeKutta; + template class RungeKutta; + template class ExplicitRungeKutta; + template class ImplicitRungeKutta; + template class EmbeddedExplicitRungeKutta; } for (V : EXTERNAL_PARALLEL_VECTORS) { - template class RungeKutta; - template class ExplicitRungeKutta; - template class ImplicitRungeKutta; - template class EmbeddedExplicitRungeKutta; + template class RungeKutta; + template class ExplicitRungeKutta; + template class ImplicitRungeKutta; + template class EmbeddedExplicitRungeKutta; } diff --git a/source/distributed/grid_refinement.inst.in b/source/distributed/grid_refinement.inst.in index cf9cb3328b..d7641c7afa 100644 --- a/source/distributed/grid_refinement.inst.in +++ b/source/distributed/grid_refinement.inst.in @@ -19,61 +19,61 @@ for (S : REAL_SCALARS; deal_II_dimension : DIMENSIONS) { #if deal_II_dimension != 1 -namespace parallel -\{ - namespace distributed - \{ + namespace parallel + \{ + namespace distributed + \{ namespace GridRefinement \{ - template - void - refine_and_coarsen_fixed_number,deal_II_dimension> - (parallel::distributed::Triangulation &, - const dealii::Vector &, - const double, - const double, - const unsigned int); + template + void + refine_and_coarsen_fixed_number,deal_II_dimension> + (parallel::distributed::Triangulation &, + const dealii::Vector &, + const double, + const double, + const unsigned int); - template - void - refine_and_coarsen_fixed_fraction,deal_II_dimension> - (parallel::distributed::Triangulation &, - const dealii::Vector &, - const double, - const double); + template + void + refine_and_coarsen_fixed_fraction,deal_II_dimension> + (parallel::distributed::Triangulation &, + const dealii::Vector &, + const double, + const double); + \} + \} \} - \} -\} #endif #if deal_II_dimension == 3 -namespace parallel -\{ - namespace distributed - \{ + namespace parallel + \{ + namespace distributed + \{ namespace GridRefinement \{ - template - void - refine_and_coarsen_fixed_number,deal_II_dimension> - (parallel::distributed::Triangulation &, - const dealii::Vector &, - const double, - const double, - const unsigned int); + template + void + refine_and_coarsen_fixed_number,deal_II_dimension> + (parallel::distributed::Triangulation &, + const dealii::Vector &, + const double, + const double, + const unsigned int); - template - void - refine_and_coarsen_fixed_fraction,deal_II_dimension> - (parallel::distributed::Triangulation &, - const dealii::Vector &, - const double, - const double); + template + void + refine_and_coarsen_fixed_fraction,deal_II_dimension> + (parallel::distributed::Triangulation &, + const dealii::Vector &, + const double, + const double); + \} + \} \} - \} -\} #endif } diff --git a/source/distributed/shared_tria.inst.in b/source/distributed/shared_tria.inst.in index 011929824e..df5fcfcd5f 100644 --- a/source/distributed/shared_tria.inst.in +++ b/source/distributed/shared_tria.inst.in @@ -17,20 +17,20 @@ for (deal_II_dimension : DIMENSIONS) - { +{ namespace parallel \{ - namespace shared - \{ - template class Triangulation; + namespace shared + \{ + template class Triangulation; # if deal_II_dimension < 3 - template class Triangulation; + template class Triangulation; # endif # if deal_II_dimension < 2 - template class Triangulation; + template class Triangulation; # endif - \} + \} \} - } +} diff --git a/source/distributed/solution_transfer.inst.in b/source/distributed/solution_transfer.inst.in index a5cc1a5fef..671eec5587 100644 --- a/source/distributed/solution_transfer.inst.in +++ b/source/distributed/solution_transfer.inst.in @@ -16,9 +16,9 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { - namespace parallel - \{ +{ + namespace parallel + \{ namespace distributed \{ #if deal_II_dimension > 1 @@ -53,6 +53,6 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) #endif #endif \} - \} + \} - } +} diff --git a/source/distributed/tria.inst.in b/source/distributed/tria.inst.in index 529f009166..97de2c1487 100644 --- a/source/distributed/tria.inst.in +++ b/source/distributed/tria.inst.in @@ -16,55 +16,55 @@ for (deal_II_dimension : DIMENSIONS) - { +{ # ifdef DEAL_II_WITH_P4EST namespace internal \{ - namespace p4est - \{ + namespace p4est + \{ #if deal_II_dimension > 1 - template - void - init_quadrant_children - (const types::quadrant & p4est_cell, - types::quadrant (&p4est_children)[GeometryInfo::max_children_per_cell]); + template + void + init_quadrant_children + (const types::quadrant & p4est_cell, + types::quadrant (&p4est_children)[GeometryInfo::max_children_per_cell]); - template - void - init_coarse_quadrant - (types::quadrant & quad); + template + void + init_coarse_quadrant + (types::quadrant & quad); - template - bool - quadrant_is_equal - (const types::quadrant & q1, - const types::quadrant & q2); + template + bool + quadrant_is_equal + (const types::quadrant & q1, + const types::quadrant & q2); - template - bool - quadrant_is_ancestor - (const types::quadrant & q1, - const types::quadrant & q2); + template + bool + quadrant_is_ancestor + (const types::quadrant & q1, + const types::quadrant & q2); # endif - \} + \} \} # endif // DEAL_II_WITH_P4EST namespace parallel \{ - namespace distributed - \{ - template class Triangulation; + namespace distributed + \{ + template class Triangulation; # if deal_II_dimension < 3 - template class Triangulation; + template class Triangulation; # endif # if deal_II_dimension < 2 - template class Triangulation; + template class Triangulation; # endif - \} + \} \} - } +} diff --git a/source/distributed/tria_base.inst.in b/source/distributed/tria_base.inst.in index 074deeb9ba..01c4bb687c 100644 --- a/source/distributed/tria_base.inst.in +++ b/source/distributed/tria_base.inst.in @@ -17,17 +17,17 @@ for (deal_II_dimension : DIMENSIONS) - { +{ namespace parallel \{ - template class Triangulation; + template class Triangulation; # if deal_II_dimension < 3 - template class Triangulation; + template class Triangulation; # endif # if deal_II_dimension < 2 - template class Triangulation; + template class Triangulation; # endif \} - } +} diff --git a/source/dofs/block_info.inst.in b/source/dofs/block_info.inst.in index a3c28d04c2..bf05819a08 100644 --- a/source/dofs/block_info.inst.in +++ b/source/dofs/block_info.inst.in @@ -15,7 +15,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template void BlockInfo::initialize(const DoFHandler&, bool, bool); template void BlockInfo::initialize_local(const DoFHandler&); @@ -28,5 +28,5 @@ for (deal_II_dimension : DIMENSIONS) template void BlockInfo::initialize(const DoFHandler<1,3>&, bool, bool); template void BlockInfo::initialize_local(const DoFHandler<1,3>&); #endif - } +} diff --git a/source/dofs/dof_accessor.inst.in b/source/dofs/dof_accessor.inst.in index 24e7f90d8f..1a76b30e59 100644 --- a/source/dofs/dof_accessor.inst.in +++ b/source/dofs/dof_accessor.inst.in @@ -17,13 +17,13 @@ // TODO: This could surely be made more systematic! for (deal_II_dimension : DIMENSIONS; lda : BOOL) - { +{ // explicit instantiations (for DoFHandler) #if deal_II_dimension == 2 template class DoFAccessor<1, DoFHandler<2>, lda>; - + template class TriaRawIterator , lda> >; template class TriaIterator , lda> >; template class TriaActiveIterator, lda> >; @@ -32,7 +32,7 @@ for (deal_II_dimension : DIMENSIONS; lda : BOOL) #if deal_II_dimension == 3 template class DoFAccessor<1, DoFHandler<3>, lda>; template class DoFAccessor<2, DoFHandler<3>, lda>; - + template class TriaRawIterator , lda> >; template class TriaIterator , lda> >; template class TriaActiveIterator, lda> >; @@ -66,7 +66,7 @@ for (deal_II_dimension : DIMENSIONS; lda : BOOL) template class TriaRawIterator , lda> >; template class TriaIterator , lda> >; template class TriaActiveIterator, lda> >; - + template class DoFAccessor<2, hp::DoFHandler<3>, lda>; template class TriaRawIterator , lda> >; template class TriaIterator , lda> >; @@ -103,11 +103,11 @@ for (deal_II_dimension : DIMENSIONS; lda : BOOL) template class DoFCellAccessor, lda>; template class - TriaRawIterator , lda> >; + TriaRawIterator , lda> >; template class - TriaIterator , lda> >; + TriaIterator , lda> >; template class - TriaActiveIterator, lda> >; + TriaActiveIterator, lda> >; #endif @@ -115,11 +115,11 @@ for (deal_II_dimension : DIMENSIONS; lda : BOOL) template class DoFCellAccessor, lda>; template class - TriaRawIterator , lda> >; + TriaRawIterator , lda> >; template class - TriaIterator , lda> >; + TriaIterator , lda> >; template class - TriaActiveIterator, lda> >; + TriaActiveIterator, lda> >; #endif @@ -144,11 +144,11 @@ for (deal_II_dimension : DIMENSIONS; lda : BOOL) template class DoFCellAccessor, lda>; template class - TriaRawIterator , lda> >; + TriaRawIterator , lda> >; template class - TriaIterator , lda> >; + TriaIterator , lda> >; template class - TriaActiveIterator, lda> >; + TriaActiveIterator, lda> >; #endif @@ -156,11 +156,11 @@ for (deal_II_dimension : DIMENSIONS; lda : BOOL) template class DoFCellAccessor, lda>; template class - TriaRawIterator , lda> >; + TriaRawIterator , lda> >; template class - TriaIterator , lda> >; + TriaIterator , lda> >; template class - TriaActiveIterator, lda> >; + TriaActiveIterator, lda> >; #endif - } +} diff --git a/source/dofs/dof_accessor_get.inst.in b/source/dofs/dof_accessor_get.inst.in index a854598aa3..fb747c22c8 100644 --- a/source/dofs/dof_accessor_get.inst.in +++ b/source/dofs/dof_accessor_get.inst.in @@ -16,62 +16,62 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; lda : BOOL) - { +{ template - void - DoFCellAccessor, lda>::get_interpolated_dof_values - (const VEC&, Vector&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::get_interpolated_dof_values + (const VEC&, Vector&, + const unsigned int fe_index) const; #if deal_II_dimension != 3 template - void - DoFCellAccessor, lda>::get_interpolated_dof_values - (const VEC&, Vector&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::get_interpolated_dof_values + (const VEC&, Vector&, + const unsigned int fe_index) const; #endif #if deal_II_dimension == 3 template - void - DoFCellAccessor, lda>::get_interpolated_dof_values - (const VEC&, Vector&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::get_interpolated_dof_values + (const VEC&, Vector&, + const unsigned int fe_index) const; #endif - } +} for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; lda : BOOL) - { +{ template - void - DoFCellAccessor, lda>::get_interpolated_dof_values - (const VEC&, Vector&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::get_interpolated_dof_values + (const VEC&, Vector&, + const unsigned int fe_index) const; #if deal_II_dimension != 3 template - void - DoFCellAccessor, lda>::get_interpolated_dof_values - (const VEC&, Vector&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::get_interpolated_dof_values + (const VEC&, Vector&, + const unsigned int fe_index) const; #endif #if deal_II_dimension == 3 template - void - DoFCellAccessor, lda>::get_interpolated_dof_values - (const VEC&, Vector&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::get_interpolated_dof_values + (const VEC&, Vector&, + const unsigned int fe_index) const; #endif - } +} diff --git a/source/dofs/dof_accessor_set.inst.in b/source/dofs/dof_accessor_set.inst.in index 4bcf10be7e..5219e47506 100644 --- a/source/dofs/dof_accessor_set.inst.in +++ b/source/dofs/dof_accessor_set.inst.in @@ -16,62 +16,62 @@ for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; lda : BOOL) - { +{ template - void - DoFCellAccessor, lda>::set_dof_values_by_interpolation - (const Vector&, VEC&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::set_dof_values_by_interpolation + (const Vector&, VEC&, + const unsigned int fe_index) const; #if deal_II_dimension != 3 template - void - DoFCellAccessor, lda>::set_dof_values_by_interpolation - (const Vector&, VEC&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::set_dof_values_by_interpolation + (const Vector&, VEC&, + const unsigned int fe_index) const; #endif #if deal_II_dimension == 3 template - void - DoFCellAccessor, lda>::set_dof_values_by_interpolation - (const Vector&, VEC&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::set_dof_values_by_interpolation + (const Vector&, VEC&, + const unsigned int fe_index) const; #endif - } +} for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; lda : BOOL) - { +{ template - void - DoFCellAccessor, lda>::set_dof_values_by_interpolation - (const Vector&, VEC&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::set_dof_values_by_interpolation + (const Vector&, VEC&, + const unsigned int fe_index) const; #if deal_II_dimension != 3 template - void - DoFCellAccessor, lda>::set_dof_values_by_interpolation - (const Vector&, VEC&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::set_dof_values_by_interpolation + (const Vector&, VEC&, + const unsigned int fe_index) const; #endif #if deal_II_dimension == 3 template - void - DoFCellAccessor, lda>::set_dof_values_by_interpolation - (const Vector&, VEC&, - const unsigned int fe_index) const; + void + DoFCellAccessor, lda>::set_dof_values_by_interpolation + (const Vector&, VEC&, + const unsigned int fe_index) const; #endif - } +} diff --git a/source/dofs/dof_handler.inst.in b/source/dofs/dof_handler.inst.in index e493928694..cacf64f260 100644 --- a/source/dofs/dof_handler.inst.in +++ b/source/dofs/dof_handler.inst.in @@ -15,9 +15,9 @@ for (scalar: REAL_SCALARS; deal_II_dimension : DIMENSIONS) - { +{ template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; - + #if deal_II_dimension < 3 template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; #endif @@ -25,13 +25,13 @@ for (scalar: REAL_SCALARS; deal_II_dimension : DIMENSIONS) #if deal_II_dimension == 1 template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; #endif - - } - + +} + for (scalar: COMPLEX_SCALARS; deal_II_dimension : DIMENSIONS) - { +{ template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; - + #if deal_II_dimension < 3 template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; #endif @@ -39,21 +39,21 @@ for (scalar: COMPLEX_SCALARS; deal_II_dimension : DIMENSIONS) #if deal_II_dimension == 1 template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; #endif - - } + +} for (deal_II_dimension : DIMENSIONS) - { +{ namespace internal \{ - template const types::global_dof_index * dummy (); - template std::string policy_to_string(const dealii::internal::DoFHandler::Policy:: - PolicyBase &); - + template const types::global_dof_index * dummy (); + template std::string policy_to_string(const dealii::internal::DoFHandler::Policy:: + PolicyBase &); + #if deal_II_dimension < 3 - template const types::global_dof_index * dummy (); - template std::string policy_to_string(const dealii::internal::DoFHandler::Policy:: - PolicyBase &); + template const types::global_dof_index * dummy (); + template std::string policy_to_string(const dealii::internal::DoFHandler::Policy:: + PolicyBase &); #endif \} @@ -66,126 +66,126 @@ for (deal_II_dimension : DIMENSIONS) #if deal_II_dimension == 3 template class DoFHandler<1,deal_II_dimension>; - + template types::global_dof_index DoFHandler<1,3>:: get_dof_index<1> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index) const; + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index) const; #endif -template -types::global_dof_index -DoFHandler:: -get_dof_index<1> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index) const; + template + types::global_dof_index + DoFHandler:: + get_dof_index<1> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index) const; #if deal_II_dimension < 3 -template -types::global_dof_index -DoFHandler:: -get_dof_index<1> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index) const; + template + types::global_dof_index + DoFHandler:: + get_dof_index<1> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index) const; #endif #if deal_II_dimension >= 2 -template -types::global_dof_index -DoFHandler:: -get_dof_index<2> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index) const; + template + types::global_dof_index + DoFHandler:: + get_dof_index<2> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index) const; #if deal_II_dimension < 3 -template -types::global_dof_index -DoFHandler:: -get_dof_index<2> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index) const; + template + types::global_dof_index + DoFHandler:: + get_dof_index<2> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index) const; #endif #if deal_II_dimension >= 3 -template -types::global_dof_index -DoFHandler:: -get_dof_index<3> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index) const; + template + types::global_dof_index + DoFHandler:: + get_dof_index<3> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index) const; #endif #endif -template -void -DoFHandler:: -set_dof_index<1> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const types::global_dof_index global_index) const; + template + void + DoFHandler:: + set_dof_index<1> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #if deal_II_dimension < 3 -template -void -DoFHandler:: -set_dof_index<1> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const types::global_dof_index global_index) const; + template + void + DoFHandler:: + set_dof_index<1> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #endif #if deal_II_dimension < 2 -template -void -DoFHandler:: -set_dof_index<1> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const types::global_dof_index global_index) const; + template + void + DoFHandler:: + set_dof_index<1> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #endif #if deal_II_dimension >= 2 -template -void -DoFHandler:: -set_dof_index<2> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const types::global_dof_index global_index) const; + template + void + DoFHandler:: + set_dof_index<2> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #if deal_II_dimension < 3 -template -void -DoFHandler:: -set_dof_index<2> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const types::global_dof_index global_index) const; + template + void + DoFHandler:: + set_dof_index<2> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #endif #if deal_II_dimension >= 3 -template -void -DoFHandler:: -set_dof_index<3> (const unsigned int obj_level, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const types::global_dof_index global_index) const; + template + void + DoFHandler:: + set_dof_index<3> (const unsigned int obj_level, + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index) const; #endif #endif - } +} diff --git a/source/dofs/dof_handler_policy.inst.in b/source/dofs/dof_handler_policy.inst.in index defe7b4c2a..b8cb3661b1 100644 --- a/source/dofs/dof_handler_policy.inst.in +++ b/source/dofs/dof_handler_policy.inst.in @@ -16,32 +16,32 @@ for (deal_II_dimension : DIMENSIONS) { -namespace internal -\{ - namespace DoFHandler - \{ + namespace internal + \{ + namespace DoFHandler + \{ namespace Policy \{ - template class PolicyBase; - template class Sequential; - template class ParallelShared; - template class ParallelDistributed; + template class PolicyBase; + template class Sequential; + template class ParallelShared; + template class ParallelDistributed; #if deal_II_dimension==1 || deal_II_dimension==2 - template class PolicyBase; - template class Sequential; - template class ParallelShared; - template class ParallelDistributed; + template class PolicyBase; + template class Sequential; + template class ParallelShared; + template class ParallelDistributed; #endif #if deal_II_dimension==3 - template class PolicyBase<1,3>; - template class Sequential<1,3>; - template class ParallelShared<1,3>; - template class ParallelDistributed<1,3>; + template class PolicyBase<1,3>; + template class Sequential<1,3>; + template class ParallelShared<1,3>; + template class ParallelDistributed<1,3>; #endif \} - \} -\} + \} + \} } diff --git a/source/dofs/dof_objects.inst.in b/source/dofs/dof_objects.inst.in index 85cf81449b..37cf8522fb 100644 --- a/source/dofs/dof_objects.inst.in +++ b/source/dofs/dof_objects.inst.in @@ -16,29 +16,29 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class DoFObjects; - } +} for (deal_II_dimension, structdim : DIMENSIONS) - { +{ template types::global_dof_index DoFObjects:: get_dof_index (const dealii::DoFHandler &dof_handler, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index) const; + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index) const; template void DoFObjects:: set_dof_index (const dealii::DoFHandler &dof_handler, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const types::global_dof_index global_index); + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index); #if (deal_II_dimension < 3) && (structdim < 3) @@ -46,18 +46,18 @@ for (deal_II_dimension, structdim : DIMENSIONS) types::global_dof_index DoFObjects:: get_dof_index (const dealii::DoFHandler &dof_handler, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index) const; + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index) const; template void DoFObjects:: set_dof_index (const dealii::DoFHandler &dof_handler, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const types::global_dof_index global_index); + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index); #endif @@ -67,18 +67,18 @@ for (deal_II_dimension, structdim : DIMENSIONS) types::global_dof_index DoFObjects:: get_dof_index (const dealii::DoFHandler<1,3> &dof_handler, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index) const; + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index) const; template void DoFObjects:: set_dof_index (const dealii::DoFHandler<1,3> &dof_handler, - const unsigned int obj_index, - const unsigned int fe_index, - const unsigned int local_index, - const types::global_dof_index global_index); + const unsigned int obj_index, + const unsigned int fe_index, + const unsigned int local_index, + const types::global_dof_index global_index); #endif - } +} diff --git a/source/dofs/dof_renumbering.inst.in b/source/dofs/dof_renumbering.inst.in index 27a403e943..c8dcf778de 100644 --- a/source/dofs/dof_renumbering.inst.in +++ b/source/dofs/dof_renumbering.inst.in @@ -15,63 +15,63 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace DoFRenumbering - \{ - namespace boost - \{ + \{ + namespace boost + \{ //TODO[WB]: also implement the following boost for hp DoFHandlers etc. - \} + \} // non-boost functions: - template - void Cuthill_McKee > - (DoFHandler&, - const bool, - const bool, - const std::vector&); - - template - void - compute_Cuthill_McKee > - (std::vector&, - const DoFHandler&, - const bool, - const bool, - const std::vector&); - - template - void component_wise - (DoFHandler&, - const std::vector&); - - template - void block_wise - (DoFHandler&); - - template - void subdomain_wise > - (DoFHandler &); - - template - void - compute_subdomain_wise (std::vector &new_dof_indices, - const DoFHandler &dof_handler); - - \} // namespace DoFRenumbering + template + void Cuthill_McKee > + (DoFHandler&, + const bool, + const bool, + const std::vector&); + + template + void + compute_Cuthill_McKee > + (std::vector&, + const DoFHandler&, + const bool, + const bool, + const std::vector&); + + template + void component_wise + (DoFHandler&, + const std::vector&); + + template + void block_wise + (DoFHandler&); + + template + void subdomain_wise > + (DoFHandler &); + + template + void + compute_subdomain_wise (std::vector &new_dof_indices, + const DoFHandler &dof_handler); + + \} // namespace DoFRenumbering #endif - } +} //TODO[SP]: replace by // where applicable and move to codimension cases above also when applicable for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension == deal_II_space_dimension -namespace DoFRenumbering - \{ - namespace boost + namespace DoFRenumbering + \{ + namespace boost \{ //TODO[WB]: also implement the following boost for hp DoFHandlers etc. template @@ -81,7 +81,7 @@ namespace DoFRenumbering template void compute_Cuthill_McKee (std::vector &, - const DoFHandler &, bool, bool); + const DoFHandler &, bool, bool); template void @@ -90,7 +90,7 @@ namespace DoFRenumbering template void compute_king_ordering (std::vector &, - const DoFHandler &, bool, bool); + const DoFHandler &, bool, bool); template void @@ -99,7 +99,7 @@ namespace DoFRenumbering template void compute_minimum_degree (std::vector &, - const DoFHandler &, bool, bool); + const DoFHandler &, bool, bool); template @@ -109,7 +109,7 @@ namespace DoFRenumbering template void compute_Cuthill_McKee (std::vector &, - const hp::DoFHandler &, bool, bool); + const hp::DoFHandler &, bool, bool); template void @@ -118,7 +118,7 @@ namespace DoFRenumbering template void compute_king_ordering (std::vector &, - const hp::DoFHandler &, bool, bool); + const hp::DoFHandler &, bool, bool); template void @@ -127,197 +127,197 @@ namespace DoFRenumbering template void compute_minimum_degree (std::vector &, - const hp::DoFHandler &, bool, bool); + const hp::DoFHandler &, bool, bool); \} // non-boost functions: template - void Cuthill_McKee > - (hp::DoFHandler&, - const bool, - const bool, - const std::vector&); + void Cuthill_McKee > + (hp::DoFHandler&, + const bool, + const bool, + const std::vector&); template - void - compute_Cuthill_McKee > - (std::vector&, - const hp::DoFHandler&, - const bool, - const bool, - const std::vector&); + void + compute_Cuthill_McKee > + (std::vector&, + const hp::DoFHandler&, + const bool, + const bool, + const std::vector&); template - void component_wise - (hp::DoFHandler&, - const std::vector&); + void component_wise + (hp::DoFHandler&, + const std::vector&); template - void component_wise - (DoFHandler&, - unsigned int, - const std::vector&); + void component_wise + (DoFHandler&, + unsigned int, + const std::vector&); template - void block_wise - (hp::DoFHandler&); + void block_wise + (hp::DoFHandler&); template - void block_wise - (DoFHandler&, - unsigned int); + void block_wise + (DoFHandler&, + unsigned int); template - void hierarchical - (DoFHandler&); + void hierarchical + (DoFHandler&); template void - cell_wise > - (DoFHandler&, - const std::vector::active_cell_iterator>&); + cell_wise > + (DoFHandler&, + const std::vector::active_cell_iterator>&); template void - compute_cell_wise > - (std::vector&, std::vector&, - const DoFHandler&, - const std::vector::active_cell_iterator>&); + compute_cell_wise > + (std::vector&, std::vector&, + const DoFHandler&, + const std::vector::active_cell_iterator>&); template void - cell_wise > - (DoFHandler&, unsigned int, - const std::vector::level_cell_iterator>&); + cell_wise > + (DoFHandler&, unsigned int, + const std::vector::level_cell_iterator>&); template void - compute_cell_wise > - (std::vector&, std::vector&, - const DoFHandler&, unsigned int, - const std::vector::level_cell_iterator>&); + compute_cell_wise > + (std::vector&, std::vector&, + const DoFHandler&, unsigned int, + const std::vector::level_cell_iterator>&); template void - compute_downstream > - (std::vector&,std::vector&, - const DoFHandler&, const Point&, - const bool); + compute_downstream > + (std::vector&,std::vector&, + const DoFHandler&, const Point&, + const bool); template - void - clockwise_dg > - (DoFHandler&, const Point&, bool); + void + clockwise_dg > + (DoFHandler&, const Point&, bool); template - void - compute_clockwise_dg > - (std::vector&, const DoFHandler&, - const Point&, const bool); + void + compute_clockwise_dg > + (std::vector&, const DoFHandler&, + const Point&, const bool); // Renumbering for hp::DoFHandler template void - cell_wise > - (hp::DoFHandler&, - const std::vector::active_cell_iterator>&); + cell_wise > + (hp::DoFHandler&, + const std::vector::active_cell_iterator>&); template void - compute_cell_wise > - (std::vector&, std::vector&, - const hp::DoFHandler&, - const std::vector::active_cell_iterator>&); + compute_cell_wise > + (std::vector&, std::vector&, + const hp::DoFHandler&, + const std::vector::active_cell_iterator>&); template void - compute_downstream > - (std::vector&,std::vector&, - const hp::DoFHandler&, - const Point&, - const bool); + compute_downstream > + (std::vector&,std::vector&, + const hp::DoFHandler&, + const Point&, + const bool); template - void - clockwise_dg > - (hp::DoFHandler&, - const Point&, bool); + void + clockwise_dg > + (hp::DoFHandler&, + const Point&, bool); template - void - compute_clockwise_dg > - (std::vector&, - const hp::DoFHandler&, - const Point&, - const bool); + void + compute_clockwise_dg > + (std::vector&, + const hp::DoFHandler&, + const Point&, + const bool); // MG template - void downstream - (DoFHandler&, - const unsigned int, - const Point&, - const bool); + void downstream + (DoFHandler&, + const unsigned int, + const Point&, + const bool); template - void clockwise_dg - (DoFHandler&, - const unsigned int, - const Point&, bool); + void clockwise_dg + (DoFHandler&, + const unsigned int, + const Point&, bool); // Generic numbering schemes template - void random > - (DoFHandler &); + void random > + (DoFHandler &); template - void - compute_random > - (std::vector&, - const DoFHandler &); + void + compute_random > + (std::vector&, + const DoFHandler &); template - void sort_selected_dofs_back > - (DoFHandler &, - const std::vector &); + void sort_selected_dofs_back > + (DoFHandler &, + const std::vector &); template - void - compute_sort_selected_dofs_back > - (std::vector&, - const DoFHandler &, - const std::vector &); + void + compute_sort_selected_dofs_back > + (std::vector&, + const DoFHandler &, + const std::vector &); template - void random > - (hp::DoFHandler &); + void random > + (hp::DoFHandler &); template - void - compute_random > - (std::vector&, - const hp::DoFHandler &); + void + compute_random > + (std::vector&, + const hp::DoFHandler &); template - void sort_selected_dofs_back > - (hp::DoFHandler &, - const std::vector &); + void sort_selected_dofs_back > + (hp::DoFHandler &, + const std::vector &); template - void - compute_sort_selected_dofs_back > - (std::vector&, - const hp::DoFHandler &, - const std::vector &); + void + compute_sort_selected_dofs_back > + (std::vector&, + const hp::DoFHandler &, + const std::vector &); template - void subdomain_wise > - (hp::DoFHandler &); + void subdomain_wise > + (hp::DoFHandler &); template - void Cuthill_McKee > - (DoFHandler&, - const unsigned int, - const bool, - const std::vector&); + void Cuthill_McKee > + (DoFHandler&, + const unsigned int, + const bool, + const std::vector&); \} // namespace DoFRenumbering #endif - } +} diff --git a/source/dofs/dof_tools.inst.in b/source/dofs/dof_tools.inst.in index 2fca0bb11e..8495a6ff4d 100644 --- a/source/dofs/dof_tools.inst.in +++ b/source/dofs/dof_tools.inst.in @@ -18,760 +18,760 @@ for (deal_II_dimension : DIMENSIONS) { #if deal_II_dimension > 1 - template - void - DoFTools::extract_locally_relevant_dofs > - (const DoFHandler & dof_handler, - IndexSet & dof_set); + template + void + DoFTools::extract_locally_relevant_dofs > + (const DoFHandler & dof_handler, + IndexSet & dof_set); #endif #if deal_II_dimension > 2 - template - void - DoFTools::extract_locally_relevant_dofs > - (const DoFHandler & dof_handler, - IndexSet & dof_set); + template + void + DoFTools::extract_locally_relevant_dofs > + (const DoFHandler & dof_handler, + IndexSet & dof_set); #endif - template - std::vector - DoFTools::make_vertex_patches (SparsityPattern&, const DoFHandler&, - unsigned int, bool, bool, bool, bool, bool); + template + std::vector + DoFTools::make_vertex_patches (SparsityPattern&, const DoFHandler&, + unsigned int, bool, bool, bool, bool, bool); - template - std::vector - DoFTools::make_vertex_patches (SparsityPattern&, const DoFHandler&, - unsigned int, const BlockMask&, bool, bool, bool, bool); + template + std::vector + DoFTools::make_vertex_patches (SparsityPattern&, const DoFHandler&, + unsigned int, const BlockMask&, bool, bool, bool, bool); - template - void DoFTools::make_single_patch (SparsityPattern&, const DoFHandler&, - unsigned int, bool); + template + void DoFTools::make_single_patch (SparsityPattern&, const DoFHandler&, + unsigned int, bool); - template - void DoFTools::make_child_patches(SparsityPattern&, const DoFHandler&, - unsigned int, bool, bool); + template + void DoFTools::make_child_patches(SparsityPattern&, const DoFHandler&, + unsigned int, bool, bool); // TODO: can cleanup a bit more to fit into the scheme used above -template -void -DoFTools::distribute_cell_to_dof_vector > -(const DoFHandler &dof_handler, - const Vector &cell_data, - Vector &dof_data, - const unsigned int component); -template -void -DoFTools::distribute_cell_to_dof_vector > -(const DoFHandler &dof_handler, - const Vector &cell_data, - Vector &dof_data, - const unsigned int component); - -template -void -DoFTools::distribute_cell_to_dof_vector > -(const hp::DoFHandler &dof_handler, - const Vector &cell_data, - Vector &dof_data, - const unsigned int component); -template -void -DoFTools::distribute_cell_to_dof_vector > -(const hp::DoFHandler &dof_handler, - const Vector &cell_data, - Vector &dof_data, - const unsigned int component); - - - -template void DoFTools::extract_level_dofs > -(const unsigned int level, - const DoFHandler&, - const ComponentMask &, - std::vector&); - -template void DoFTools::extract_level_dofs > -(const unsigned int level, - const DoFHandler&, - const BlockMask &, - std::vector&); + template + void + DoFTools::distribute_cell_to_dof_vector > + (const DoFHandler &dof_handler, + const Vector &cell_data, + Vector &dof_data, + const unsigned int component); + template + void + DoFTools::distribute_cell_to_dof_vector > + (const DoFHandler &dof_handler, + const Vector &cell_data, + Vector &dof_data, + const unsigned int component); + + template + void + DoFTools::distribute_cell_to_dof_vector > + (const hp::DoFHandler &dof_handler, + const Vector &cell_data, + Vector &dof_data, + const unsigned int component); + template + void + DoFTools::distribute_cell_to_dof_vector > + (const hp::DoFHandler &dof_handler, + const Vector &cell_data, + Vector &dof_data, + const unsigned int component); + + + + template void DoFTools::extract_level_dofs > + (const unsigned int level, + const DoFHandler&, + const ComponentMask &, + std::vector&); + + template void DoFTools::extract_level_dofs > + (const unsigned int level, + const DoFHandler&, + const BlockMask &, + std::vector&); #if deal_II_dimension > 1 -template void DoFTools::extract_level_dofs > -(const unsigned int level, - const DoFHandler<1, deal_II_dimension>&, - const BlockMask &, - std::vector&); + template void DoFTools::extract_level_dofs > + (const unsigned int level, + const DoFHandler<1, deal_II_dimension>&, + const BlockMask &, + std::vector&); #endif #if deal_II_dimension > 2 -template void DoFTools::extract_level_dofs > -(const unsigned int level, - const DoFHandler<2, deal_II_dimension>&, - const BlockMask &, - std::vector&); + template void DoFTools::extract_level_dofs > + (const unsigned int level, + const DoFHandler<2, deal_II_dimension>&, + const BlockMask &, + std::vector&); #endif -template -void -DoFTools::extract_boundary_dofs > -(const DoFHandler &, - const ComponentMask &, - std::vector &, - const std::set &); - -template -void -DoFTools::extract_boundary_dofs > -(const hp::DoFHandler &, - const ComponentMask &, - std::vector &, - const std::set &); - -template -void -DoFTools::extract_boundary_dofs > -(const DoFHandler &, - const ComponentMask &, - IndexSet &, - const std::set &); - -template -void -DoFTools::extract_boundary_dofs > -(const hp::DoFHandler &, - const ComponentMask &, - IndexSet &, - const std::set &); - -template -void -DoFTools::extract_dofs_with_support_on_boundary > -(const DoFHandler &, - const ComponentMask &, - std::vector &, - const std::set &); -template -void -DoFTools::extract_dofs_with_support_on_boundary > -(const hp::DoFHandler &, - const ComponentMask &, - std::vector &, - const std::set &); - -template -void -DoFTools::extract_hanging_node_dofs -(const DoFHandler &dof_handler, - std::vector &selected_dofs); - -template -void -DoFTools::extract_subdomain_dofs > -(const DoFHandler &dof_handler, - const types::subdomain_id subdomain_id, - std::vector &selected_dofs); -template -void -DoFTools::extract_subdomain_dofs > -(const hp::DoFHandler &dof_handler, - const types::subdomain_id subdomain_id, - std::vector &selected_dofs); - -template -void -DoFTools::extract_locally_owned_dofs > -(const DoFHandler & dof_handler, - IndexSet & dof_set); - -template -void -DoFTools::extract_locally_owned_dofs > -(const hp::DoFHandler & dof_handler, - IndexSet & dof_set); - -template -void -DoFTools::extract_locally_active_dofs > -(const DoFHandler & dof_handler, - IndexSet & dof_set); - -template -void -DoFTools::extract_locally_active_dofs > -(const hp::DoFHandler & dof_handler, - IndexSet & dof_set); - -template -void -DoFTools::extract_locally_relevant_dofs > -(const DoFHandler & dof_handler, - IndexSet & dof_set); - -template -void -DoFTools::extract_locally_relevant_dofs > -(const hp::DoFHandler & dof_handler, - IndexSet & dof_set); - -template -void -DoFTools::extract_locally_relevant_level_dofs > -(const DoFHandler & dof_handler, - const unsigned int level, - IndexSet & dof_set); - -template -void -DoFTools::extract_constant_modes > -(const DoFHandler &dof_handler, - const ComponentMask &selected_components, - std::vector > &constant_modes); - -template -void -DoFTools::extract_constant_modes > -(const hp::DoFHandler &dof_handler, - const ComponentMask &selected_components, - std::vector > &constant_modes); - -template -void -DoFTools::get_active_fe_indices > -(const DoFHandler &dof_handler, - std::vector &active_fe_indices); - -template -void -DoFTools::get_active_fe_indices > -(const hp::DoFHandler &dof_handler, - std::vector &active_fe_indices); - -template -void -DoFTools::get_subdomain_association > -(const DoFHandler &dof_handler, - std::vector &subdomain_association); -template -void -DoFTools::get_subdomain_association > -(const hp::DoFHandler &dof_handler, - std::vector &subdomain_association); - -template -std::vector -DoFTools::locally_owned_dofs_per_subdomain > -(const DoFHandler &dof_handler); -template -std::vector -DoFTools::locally_owned_dofs_per_subdomain > -(const hp::DoFHandler &dof_handler); - -template -std::vector -DoFTools::locally_relevant_dofs_per_subdomain > -(const DoFHandler &dof_handler); -template -std::vector -DoFTools::locally_relevant_dofs_per_subdomain > -(const hp::DoFHandler &dof_handler); - -template -unsigned int -DoFTools::count_dofs_with_subdomain_association > -(const DoFHandler &, - const types::subdomain_id); -template -IndexSet -DoFTools::dof_indices_with_subdomain_association > -(const DoFHandler &, - const types::subdomain_id); -template -void -DoFTools::count_dofs_with_subdomain_association > -(const DoFHandler &, - const types::subdomain_id, - std::vector &); - -template -unsigned int -DoFTools::count_dofs_with_subdomain_association > -(const hp::DoFHandler &, - const types::subdomain_id); -template -IndexSet -DoFTools::dof_indices_with_subdomain_association > -(const hp::DoFHandler &, - const types::subdomain_id); -template -void -DoFTools::count_dofs_with_subdomain_association > -(const hp::DoFHandler &, - const types::subdomain_id, - std::vector &); + template + void + DoFTools::extract_boundary_dofs > + (const DoFHandler &, + const ComponentMask &, + std::vector &, + const std::set &); + + template + void + DoFTools::extract_boundary_dofs > + (const hp::DoFHandler &, + const ComponentMask &, + std::vector &, + const std::set &); + + template + void + DoFTools::extract_boundary_dofs > + (const DoFHandler &, + const ComponentMask &, + IndexSet &, + const std::set &); + + template + void + DoFTools::extract_boundary_dofs > + (const hp::DoFHandler &, + const ComponentMask &, + IndexSet &, + const std::set &); + + template + void + DoFTools::extract_dofs_with_support_on_boundary > + (const DoFHandler &, + const ComponentMask &, + std::vector &, + const std::set &); + template + void + DoFTools::extract_dofs_with_support_on_boundary > + (const hp::DoFHandler &, + const ComponentMask &, + std::vector &, + const std::set &); + + template + void + DoFTools::extract_hanging_node_dofs + (const DoFHandler &dof_handler, + std::vector &selected_dofs); + + template + void + DoFTools::extract_subdomain_dofs > + (const DoFHandler &dof_handler, + const types::subdomain_id subdomain_id, + std::vector &selected_dofs); + template + void + DoFTools::extract_subdomain_dofs > + (const hp::DoFHandler &dof_handler, + const types::subdomain_id subdomain_id, + std::vector &selected_dofs); + + template + void + DoFTools::extract_locally_owned_dofs > + (const DoFHandler & dof_handler, + IndexSet & dof_set); + + template + void + DoFTools::extract_locally_owned_dofs > + (const hp::DoFHandler & dof_handler, + IndexSet & dof_set); + + template + void + DoFTools::extract_locally_active_dofs > + (const DoFHandler & dof_handler, + IndexSet & dof_set); + + template + void + DoFTools::extract_locally_active_dofs > + (const hp::DoFHandler & dof_handler, + IndexSet & dof_set); + + template + void + DoFTools::extract_locally_relevant_dofs > + (const DoFHandler & dof_handler, + IndexSet & dof_set); + + template + void + DoFTools::extract_locally_relevant_dofs > + (const hp::DoFHandler & dof_handler, + IndexSet & dof_set); + + template + void + DoFTools::extract_locally_relevant_level_dofs > + (const DoFHandler & dof_handler, + const unsigned int level, + IndexSet & dof_set); + + template + void + DoFTools::extract_constant_modes > + (const DoFHandler &dof_handler, + const ComponentMask &selected_components, + std::vector > &constant_modes); + + template + void + DoFTools::extract_constant_modes > + (const hp::DoFHandler &dof_handler, + const ComponentMask &selected_components, + std::vector > &constant_modes); + + template + void + DoFTools::get_active_fe_indices > + (const DoFHandler &dof_handler, + std::vector &active_fe_indices); + + template + void + DoFTools::get_active_fe_indices > + (const hp::DoFHandler &dof_handler, + std::vector &active_fe_indices); + + template + void + DoFTools::get_subdomain_association > + (const DoFHandler &dof_handler, + std::vector &subdomain_association); + template + void + DoFTools::get_subdomain_association > + (const hp::DoFHandler &dof_handler, + std::vector &subdomain_association); + + template + std::vector + DoFTools::locally_owned_dofs_per_subdomain > + (const DoFHandler &dof_handler); + template + std::vector + DoFTools::locally_owned_dofs_per_subdomain > + (const hp::DoFHandler &dof_handler); + + template + std::vector + DoFTools::locally_relevant_dofs_per_subdomain > + (const DoFHandler &dof_handler); + template + std::vector + DoFTools::locally_relevant_dofs_per_subdomain > + (const hp::DoFHandler &dof_handler); + + template + unsigned int + DoFTools::count_dofs_with_subdomain_association > + (const DoFHandler &, + const types::subdomain_id); + template + IndexSet + DoFTools::dof_indices_with_subdomain_association > + (const DoFHandler &, + const types::subdomain_id); + template + void + DoFTools::count_dofs_with_subdomain_association > + (const DoFHandler &, + const types::subdomain_id, + std::vector &); + + template + unsigned int + DoFTools::count_dofs_with_subdomain_association > + (const hp::DoFHandler &, + const types::subdomain_id); + template + IndexSet + DoFTools::dof_indices_with_subdomain_association > + (const hp::DoFHandler &, + const types::subdomain_id); + template + void + DoFTools::count_dofs_with_subdomain_association > + (const hp::DoFHandler &, + const types::subdomain_id, + std::vector &); #if deal_II_dimension < 3 -template -void -DoFTools::extract_boundary_dofs > - (const DoFHandler &, - const ComponentMask &, - std::vector &, - const std::set &); - -template -void -DoFTools::extract_boundary_dofs > - (const DoFHandler &, - const ComponentMask &, - IndexSet &, - const std::set &); - -template -unsigned int -DoFTools::count_dofs_with_subdomain_association > -(const DoFHandler &, - const types::subdomain_id); - -template -IndexSet -DoFTools::dof_indices_with_subdomain_association > -(const DoFHandler &, - const types::subdomain_id); -template -void -DoFTools::count_dofs_with_subdomain_association > -(const DoFHandler &, - const types::subdomain_id, - std::vector &); - -template -unsigned int -DoFTools::count_dofs_with_subdomain_association > -(const hp::DoFHandler &, - const types::subdomain_id); - -template -IndexSet -DoFTools::dof_indices_with_subdomain_association > -(const hp::DoFHandler &, - const types::subdomain_id); - -template -void -DoFTools::get_subdomain_association > -(const DoFHandler &dof_handler, - std::vector &subdomain_association); -template -void -DoFTools::get_subdomain_association > -(const hp::DoFHandler &dof_handler, - std::vector &subdomain_association); - -template -std::vector -DoFTools::locally_owned_dofs_per_subdomain > -(const DoFHandler &dof_handler); -template -std::vector -DoFTools::locally_owned_dofs_per_subdomain > -(const hp::DoFHandler &dof_handler); - -template -std::vector -DoFTools::locally_relevant_dofs_per_subdomain > -(const DoFHandler &dof_handler); -template -std::vector -DoFTools::locally_relevant_dofs_per_subdomain > -(const hp::DoFHandler &dof_handler); - -template -void -DoFTools::count_dofs_with_subdomain_association > -(const hp::DoFHandler &, - const types::subdomain_id, - std::vector &); + template + void + DoFTools::extract_boundary_dofs > + (const DoFHandler &, + const ComponentMask &, + std::vector &, + const std::set &); + + template + void + DoFTools::extract_boundary_dofs > + (const DoFHandler &, + const ComponentMask &, + IndexSet &, + const std::set &); + + template + unsigned int + DoFTools::count_dofs_with_subdomain_association > + (const DoFHandler &, + const types::subdomain_id); + + template + IndexSet + DoFTools::dof_indices_with_subdomain_association > + (const DoFHandler &, + const types::subdomain_id); + template + void + DoFTools::count_dofs_with_subdomain_association > + (const DoFHandler &, + const types::subdomain_id, + std::vector &); + + template + unsigned int + DoFTools::count_dofs_with_subdomain_association > + (const hp::DoFHandler &, + const types::subdomain_id); + + template + IndexSet + DoFTools::dof_indices_with_subdomain_association > + (const hp::DoFHandler &, + const types::subdomain_id); + + template + void + DoFTools::get_subdomain_association > + (const DoFHandler &dof_handler, + std::vector &subdomain_association); + template + void + DoFTools::get_subdomain_association > + (const hp::DoFHandler &dof_handler, + std::vector &subdomain_association); + + template + std::vector + DoFTools::locally_owned_dofs_per_subdomain > + (const DoFHandler &dof_handler); + template + std::vector + DoFTools::locally_owned_dofs_per_subdomain > + (const hp::DoFHandler &dof_handler); + + template + std::vector + DoFTools::locally_relevant_dofs_per_subdomain > + (const DoFHandler &dof_handler); + template + std::vector + DoFTools::locally_relevant_dofs_per_subdomain > + (const hp::DoFHandler &dof_handler); + + template + void + DoFTools::count_dofs_with_subdomain_association > + (const hp::DoFHandler &, + const types::subdomain_id, + std::vector &); #endif #if deal_II_dimension == 3 -template -void -DoFTools::extract_boundary_dofs > - (const DoFHandler<1,3> &, - const ComponentMask &, - std::vector &, - const std::set &); - -template -void -DoFTools::extract_boundary_dofs > - (const DoFHandler<1,3> &, - const ComponentMask &, - IndexSet &, - const std::set &); - -template -void -DoFTools::get_subdomain_association > -(const DoFHandler<1,3> &dof_handler, - std::vector &subdomain_association); -template -void -DoFTools::get_subdomain_association > -(const hp::DoFHandler<1,3> &dof_handler, - std::vector &subdomain_association); - -template -std::vector -DoFTools::locally_owned_dofs_per_subdomain > -(const DoFHandler<1,3> &dof_handler); -template -std::vector -DoFTools::locally_owned_dofs_per_subdomain > -(const hp::DoFHandler<1,3> &dof_handler); - -template -std::vector -DoFTools::locally_relevant_dofs_per_subdomain > -(const DoFHandler<1,3> &dof_handler); -template -std::vector -DoFTools::locally_relevant_dofs_per_subdomain > -(const hp::DoFHandler<1,3> &dof_handler); - -template -unsigned int -DoFTools::count_dofs_with_subdomain_association > -(const DoFHandler<1,3> &, - const types::subdomain_id); -template -IndexSet -DoFTools::dof_indices_with_subdomain_association > -(const DoFHandler<1,3> &, - const types::subdomain_id); -template -void -DoFTools::count_dofs_with_subdomain_association > -(const DoFHandler<1,3> &, - const types::subdomain_id, - std::vector &); - -template -unsigned int -DoFTools::count_dofs_with_subdomain_association > -(const hp::DoFHandler<1,3> &, - const types::subdomain_id); -template -IndexSet -DoFTools::dof_indices_with_subdomain_association > -(const hp::DoFHandler<1,3> &, - const types::subdomain_id); -template -void -DoFTools::count_dofs_with_subdomain_association > -(const hp::DoFHandler<1,3> &, - const types::subdomain_id, - std::vector &); + template + void + DoFTools::extract_boundary_dofs > + (const DoFHandler<1,3> &, + const ComponentMask &, + std::vector &, + const std::set &); + + template + void + DoFTools::extract_boundary_dofs > + (const DoFHandler<1,3> &, + const ComponentMask &, + IndexSet &, + const std::set &); + + template + void + DoFTools::get_subdomain_association > + (const DoFHandler<1,3> &dof_handler, + std::vector &subdomain_association); + template + void + DoFTools::get_subdomain_association > + (const hp::DoFHandler<1,3> &dof_handler, + std::vector &subdomain_association); + + template + std::vector + DoFTools::locally_owned_dofs_per_subdomain > + (const DoFHandler<1,3> &dof_handler); + template + std::vector + DoFTools::locally_owned_dofs_per_subdomain > + (const hp::DoFHandler<1,3> &dof_handler); + + template + std::vector + DoFTools::locally_relevant_dofs_per_subdomain > + (const DoFHandler<1,3> &dof_handler); + template + std::vector + DoFTools::locally_relevant_dofs_per_subdomain > + (const hp::DoFHandler<1,3> &dof_handler); + + template + unsigned int + DoFTools::count_dofs_with_subdomain_association > + (const DoFHandler<1,3> &, + const types::subdomain_id); + template + IndexSet + DoFTools::dof_indices_with_subdomain_association > + (const DoFHandler<1,3> &, + const types::subdomain_id); + template + void + DoFTools::count_dofs_with_subdomain_association > + (const DoFHandler<1,3> &, + const types::subdomain_id, + std::vector &); + + template + unsigned int + DoFTools::count_dofs_with_subdomain_association > + (const hp::DoFHandler<1,3> &, + const types::subdomain_id); + template + IndexSet + DoFTools::dof_indices_with_subdomain_association > + (const hp::DoFHandler<1,3> &, + const types::subdomain_id); + template + void + DoFTools::count_dofs_with_subdomain_association > + (const hp::DoFHandler<1,3> &, + const types::subdomain_id, + std::vector &); #endif -template -void -DoFTools::count_dofs_per_component > ( - const DoFHandler&, - std::vector&, bool, std::vector); + template + void + DoFTools::count_dofs_per_component > ( + const DoFHandler&, + std::vector&, bool, std::vector); -template -void -DoFTools::count_dofs_per_component > ( - const hp::DoFHandler&, - std::vector&, bool, std::vector); + template + void + DoFTools::count_dofs_per_component > ( + const hp::DoFHandler&, + std::vector&, bool, std::vector); #if deal_II_dimension < 3 -template -void -DoFTools::count_dofs_per_component > ( - const DoFHandler&, - std::vector&, bool, std::vector); - -template -void -DoFTools::count_dofs_per_component > ( - const hp::DoFHandler&, - std::vector&, bool, std::vector); - -template -void -DoFTools::extract_level_dofs > -(const unsigned int level, - const DoFHandler&, - const ComponentMask&, - std::vector&); + template + void + DoFTools::count_dofs_per_component > ( + const DoFHandler&, + std::vector&, bool, std::vector); + + template + void + DoFTools::count_dofs_per_component > ( + const hp::DoFHandler&, + std::vector&, bool, std::vector); + + template + void + DoFTools::extract_level_dofs > + (const unsigned int level, + const DoFHandler&, + const ComponentMask&, + std::vector&); #endif #if deal_II_dimension == 3 -template -void -DoFTools::count_dofs_per_component > ( - const DoFHandler<1,3>&, - std::vector&, bool, std::vector); - -template -void -DoFTools::count_dofs_per_component > ( - const hp::DoFHandler<1,3>&, - std::vector&, bool, std::vector); - -template -void -DoFTools::extract_level_dofs > -(const unsigned int level, - const DoFHandler<1,3>&, - const ComponentMask &, - std::vector&); + template + void + DoFTools::count_dofs_per_component > ( + const DoFHandler<1,3>&, + std::vector&, bool, std::vector); + + template + void + DoFTools::count_dofs_per_component > ( + const hp::DoFHandler<1,3>&, + std::vector&, bool, std::vector); + + template + void + DoFTools::extract_level_dofs > + (const unsigned int level, + const DoFHandler<1,3>&, + const ComponentMask &, + std::vector&); #endif -template -void -DoFTools::count_dofs_per_block > ( - const DoFHandler&, - std::vector&, - const std::vector &); + template + void + DoFTools::count_dofs_per_block > ( + const DoFHandler&, + std::vector&, + const std::vector &); -template -void -DoFTools::count_dofs_per_block > ( - const hp::DoFHandler&, - std::vector&, - const std::vector &); + template + void + DoFTools::count_dofs_per_block > ( + const hp::DoFHandler&, + std::vector&, + const std::vector &); -template -void -DoFTools::map_dof_to_boundary_indices > -(const DoFHandler &, - const std::set &, - std::vector &); + template + void + DoFTools::map_dof_to_boundary_indices > + (const DoFHandler &, + const std::set &, + std::vector &); -template -void -DoFTools::map_dof_to_boundary_indices > -(const DoFHandler &, - std::vector &); + template + void + DoFTools::map_dof_to_boundary_indices > + (const DoFHandler &, + std::vector &); -template -void -DoFTools::map_dof_to_boundary_indices > -(const hp::DoFHandler &, - const std::set &, - std::vector &); + template + void + DoFTools::map_dof_to_boundary_indices > + (const hp::DoFHandler &, + const std::set &, + std::vector &); -template -void -DoFTools::map_dof_to_boundary_indices > -(const hp::DoFHandler &, - std::vector &); + template + void + DoFTools::map_dof_to_boundary_indices > + (const hp::DoFHandler &, + std::vector &); -template -void -DoFTools::map_dofs_to_support_points -(const Mapping&, - const DoFHandler&, - std::vector >&); + template + void + DoFTools::map_dofs_to_support_points + (const Mapping&, + const DoFHandler&, + std::vector >&); -template -void -DoFTools::map_dofs_to_support_points -(const hp::MappingCollection&, - const hp::DoFHandler&, - std::vector >&); + template + void + DoFTools::map_dofs_to_support_points + (const hp::MappingCollection&, + const hp::DoFHandler&, + std::vector >&); -template -void -DoFTools::map_dofs_to_support_points -(const Mapping&, - const DoFHandler&, - std::map >&); + template + void + DoFTools::map_dofs_to_support_points + (const Mapping&, + const DoFHandler&, + std::map >&); -template -void -DoFTools::map_dofs_to_support_points -(const hp::MappingCollection&, - const hp::DoFHandler&, - std::map >&); + template + void + DoFTools::map_dofs_to_support_points + (const hp::MappingCollection&, + const hp::DoFHandler&, + std::map >&); #if deal_II_dimension < 3 -template -void -DoFTools::map_dofs_to_support_points -(const Mapping&, - const DoFHandler&, - std::vector >&); - -template -void -DoFTools::map_dofs_to_support_points -(const hp::MappingCollection&, - const hp::DoFHandler&, - std::vector >&); - -template -void -DoFTools::map_dofs_to_support_points -(const Mapping&, - const DoFHandler&, - std::map >&); - -template -void -DoFTools::map_dofs_to_support_points -(const hp::MappingCollection&, - const hp::DoFHandler&, - std::map >&); - - -template -void -DoFTools::count_dofs_per_block > ( - const DoFHandler&, - std::vector&, - const std::vector &); - -template -void -DoFTools::count_dofs_per_block > ( - const hp::DoFHandler&, - std::vector&, - const std::vector &); + template + void + DoFTools::map_dofs_to_support_points + (const Mapping&, + const DoFHandler&, + std::vector >&); + + template + void + DoFTools::map_dofs_to_support_points + (const hp::MappingCollection&, + const hp::DoFHandler&, + std::vector >&); + + template + void + DoFTools::map_dofs_to_support_points + (const Mapping&, + const DoFHandler&, + std::map >&); + + template + void + DoFTools::map_dofs_to_support_points + (const hp::MappingCollection&, + const hp::DoFHandler&, + std::map >&); + + + template + void + DoFTools::count_dofs_per_block > ( + const DoFHandler&, + std::vector&, + const std::vector &); + + template + void + DoFTools::count_dofs_per_block > ( + const hp::DoFHandler&, + std::vector&, + const std::vector &); #endif #if deal_II_dimension == 3 -template -void -DoFTools::map_dofs_to_support_points<1,3> -(const Mapping<1,3>&, - const DoFHandler<1,3>&, - std::vector >&); - -template -void -DoFTools::count_dofs_per_block > ( - const DoFHandler<1,3>&, - std::vector&, - const std::vector &); - -template -void -DoFTools::count_dofs_per_block > ( - const hp::DoFHandler<1,3>&, - std::vector&, - const std::vector &); + template + void + DoFTools::map_dofs_to_support_points<1,3> + (const Mapping<1,3>&, + const DoFHandler<1,3>&, + std::vector >&); + + template + void + DoFTools::count_dofs_per_block > ( + const DoFHandler<1,3>&, + std::vector&, + const std::vector &); + + template + void + DoFTools::count_dofs_per_block > ( + const hp::DoFHandler<1,3>&, + std::vector&, + const std::vector &); #endif -template -void -DoFTools::convert_couplings_to_blocks ( - const DoFHandler&, const Table<2, Coupling>&, - std::vector >&); + template + void + DoFTools::convert_couplings_to_blocks ( + const DoFHandler&, const Table<2, Coupling>&, + std::vector >&); -template -void -DoFTools::convert_couplings_to_blocks ( - const hp::DoFHandler&, const Table<2, Coupling>&, - std::vector >&); + template + void + DoFTools::convert_couplings_to_blocks ( + const hp::DoFHandler&, const Table<2, Coupling>&, + std::vector >&); #if deal_II_dimension < 3 -template -void -DoFTools::map_dof_to_boundary_indices > -(const DoFHandler &, - const std::set &, - std::vector &); - -template -void -DoFTools::map_dof_to_boundary_indices > -(const DoFHandler &, - std::vector &); - - -template -void -DoFTools::extract_hanging_node_dofs -(const DoFHandler &dof_handler, - std::vector &selected_dofs); - - template - void - DoFTools::map_dof_to_boundary_indices > - (const hp::DoFHandler &, - const std::set &, - std::vector &); - - template - void - DoFTools::map_dof_to_boundary_indices > - (const hp::DoFHandler &, - std::vector &); + template + void + DoFTools::map_dof_to_boundary_indices > + (const DoFHandler &, + const std::set &, + std::vector &); + + template + void + DoFTools::map_dof_to_boundary_indices > + (const DoFHandler &, + std::vector &); + + + template + void + DoFTools::extract_hanging_node_dofs + (const DoFHandler &dof_handler, + std::vector &selected_dofs); + + template + void + DoFTools::map_dof_to_boundary_indices > + (const hp::DoFHandler &, + const std::set &, + std::vector &); + + template + void + DoFTools::map_dof_to_boundary_indices > + (const hp::DoFHandler &, + std::vector &); #endif #if deal_II_dimension == 3 -template -void -DoFTools::map_dof_to_boundary_indices > -(const DoFHandler<1,3> &, - const std::set &, - std::vector &); - -template -void -DoFTools::map_dof_to_boundary_indices > -(const DoFHandler<1,3> &, - std::vector &); - - -template -void -DoFTools::extract_hanging_node_dofs -(const DoFHandler<1,3> &dof_handler, - std::vector &selected_dofs); - -template -void -DoFTools::map_dof_to_boundary_indices > -(const hp::DoFHandler<1,3> &, - const std::set &, - std::vector &); - -template -void -DoFTools::map_dof_to_boundary_indices > -(const hp::DoFHandler<1,3> &, - std::vector &); + template + void + DoFTools::map_dof_to_boundary_indices > + (const DoFHandler<1,3> &, + const std::set &, + std::vector &); + + template + void + DoFTools::map_dof_to_boundary_indices > + (const DoFHandler<1,3> &, + std::vector &); + + + template + void + DoFTools::extract_hanging_node_dofs + (const DoFHandler<1,3> &dof_handler, + std::vector &selected_dofs); + + template + void + DoFTools::map_dof_to_boundary_indices > + (const hp::DoFHandler<1,3> &, + const std::set &, + std::vector &); + + template + void + DoFTools::map_dof_to_boundary_indices > + (const hp::DoFHandler<1,3> &, + std::vector &); #endif @@ -781,65 +781,65 @@ DoFTools::map_dof_to_boundary_indices > for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : DIMENSIONS) { - #if deal_II_dimension <= deal_II_space_dimension - namespace DoFTools - \{ - template - unsigned int - count_dofs_on_patch > - (const std::vector::active_cell_iterator> &patch); - - template - std::vector - get_dofs_on_patch > - (const std::vector::active_cell_iterator> &patch); - - template - unsigned int - count_dofs_on_patch > - (const std::vector::active_cell_iterator> &patch); - - template - std::vector - get_dofs_on_patch > - (const std::vector::active_cell_iterator> &patch); - - template - void - extract_dofs - (const DoFHandler&, - const ComponentMask &, - std::vector&); - - template - void - extract_dofs - (const DoFHandler&, - const BlockMask &, - std::vector&); - - template - void - extract_dofs - (const hp::DoFHandler&, - const ComponentMask &, - std::vector&); - - template - void - extract_dofs - (const hp::DoFHandler&, - const BlockMask &, - std::vector&); - - template - void - make_cell_patches - (SparsityPattern&, - const DoFHandler&, - const unsigned int, const std::vector&, - const types::global_dof_index); - - \} - #endif +#if deal_II_dimension <= deal_II_space_dimension + namespace DoFTools + \{ + template + unsigned int + count_dofs_on_patch > + (const std::vector::active_cell_iterator> &patch); + + template + std::vector + get_dofs_on_patch > + (const std::vector::active_cell_iterator> &patch); + + template + unsigned int + count_dofs_on_patch > + (const std::vector::active_cell_iterator> &patch); + + template + std::vector + get_dofs_on_patch > + (const std::vector::active_cell_iterator> &patch); + + template + void + extract_dofs + (const DoFHandler&, + const ComponentMask &, + std::vector&); + + template + void + extract_dofs + (const DoFHandler&, + const BlockMask &, + std::vector&); + + template + void + extract_dofs + (const hp::DoFHandler&, + const ComponentMask &, + std::vector&); + + template + void + extract_dofs + (const hp::DoFHandler&, + const BlockMask &, + std::vector&); + + template + void + make_cell_patches + (SparsityPattern&, + const DoFHandler&, + const unsigned int, const std::vector&, + const types::global_dof_index); + + \} +#endif } diff --git a/source/dofs/dof_tools_constraints.inst.in b/source/dofs/dof_tools_constraints.inst.in index b652ebd906..88f31caf7d 100644 --- a/source/dofs/dof_tools_constraints.inst.in +++ b/source/dofs/dof_tools_constraints.inst.in @@ -18,47 +18,47 @@ for (DH : DOFHANDLERS; deal_II_dimension : DIMENSIONS) { - template - void - DoFTools::make_hanging_node_constraints (const DH &dof_handler, - ConstraintMatrix &constraints); + template + void + DoFTools::make_hanging_node_constraints (const DH &dof_handler, + ConstraintMatrix &constraints); #if deal_II_dimension != 1 - template - void - DoFTools::make_periodicity_constraints (const DH::face_iterator &, - const DH::face_iterator &, - dealii::ConstraintMatrix &, - const ComponentMask &, - bool, bool, bool, - const FullMatrix &, - const std::vector &); - - template - void - DoFTools::make_periodicity_constraints - (const std::vector > &, - dealii::ConstraintMatrix &, - const ComponentMask &, - const std::vector &); - - - template - void - DoFTools::make_periodicity_constraints(const DH &, - const types::boundary_id, - const types::boundary_id, - const int, - dealii::ConstraintMatrix &, - const ComponentMask &); - - template - void - DoFTools::make_periodicity_constraints(const DH &, - const types::boundary_id, - const int, - dealii::ConstraintMatrix &, - const ComponentMask &); + template + void + DoFTools::make_periodicity_constraints (const DH::face_iterator &, + const DH::face_iterator &, + dealii::ConstraintMatrix &, + const ComponentMask &, + bool, bool, bool, + const FullMatrix &, + const std::vector &); + + template + void + DoFTools::make_periodicity_constraints + (const std::vector > &, + dealii::ConstraintMatrix &, + const ComponentMask &, + const std::vector &); + + + template + void + DoFTools::make_periodicity_constraints(const DH &, + const types::boundary_id, + const types::boundary_id, + const int, + dealii::ConstraintMatrix &, + const ComponentMask &); + + template + void + DoFTools::make_periodicity_constraints(const DH &, + const types::boundary_id, + const int, + dealii::ConstraintMatrix &, + const ComponentMask &); #endif } @@ -66,65 +66,65 @@ for (deal_II_dimension : DIMENSIONS) { #if deal_II_dimension < 3 -template -void -DoFTools:: -make_hanging_node_constraints (const DoFHandler &dof_handler, - ConstraintMatrix &constraints); + template + void + DoFTools:: + make_hanging_node_constraints (const DoFHandler &dof_handler, + ConstraintMatrix &constraints); #endif #if deal_II_dimension == 3 -template -void -DoFTools:: -make_hanging_node_constraints (const DoFHandler<1,3> &dof_handler, - ConstraintMatrix &constraints); + template + void + DoFTools:: + make_hanging_node_constraints (const DoFHandler<1,3> &dof_handler, + ConstraintMatrix &constraints); #endif -template -void -DoFTools::make_zero_boundary_constraints -(const DoFHandler &, - ConstraintMatrix &, - const ComponentMask &); - -template -void -DoFTools::make_zero_boundary_constraints -(const DoFHandler &, - const types::boundary_id , - ConstraintMatrix &, - const ComponentMask &); - -template -void -DoFTools::make_zero_boundary_constraints -(const hp::DoFHandler &, - ConstraintMatrix &, - const ComponentMask &); - -template -void -DoFTools::make_zero_boundary_constraints -(const hp::DoFHandler &, - const types::boundary_id , - ConstraintMatrix &, - const ComponentMask &); - -template -void -DoFTools::compute_intergrid_constraints ( - const DoFHandler &, const unsigned int, - const DoFHandler &, const unsigned int, - const InterGridMap > &, - ConstraintMatrix&); - -template -void -DoFTools::compute_intergrid_transfer_representation -(const DoFHandler &, const unsigned int, - const DoFHandler &, const unsigned int, - const InterGridMap > &, - std::vector > &); + template + void + DoFTools::make_zero_boundary_constraints + (const DoFHandler &, + ConstraintMatrix &, + const ComponentMask &); + + template + void + DoFTools::make_zero_boundary_constraints + (const DoFHandler &, + const types::boundary_id , + ConstraintMatrix &, + const ComponentMask &); + + template + void + DoFTools::make_zero_boundary_constraints + (const hp::DoFHandler &, + ConstraintMatrix &, + const ComponentMask &); + + template + void + DoFTools::make_zero_boundary_constraints + (const hp::DoFHandler &, + const types::boundary_id , + ConstraintMatrix &, + const ComponentMask &); + + template + void + DoFTools::compute_intergrid_constraints ( + const DoFHandler &, const unsigned int, + const DoFHandler &, const unsigned int, + const InterGridMap > &, + ConstraintMatrix&); + + template + void + DoFTools::compute_intergrid_transfer_representation + (const DoFHandler &, const unsigned int, + const DoFHandler &, const unsigned int, + const InterGridMap > &, + std::vector > &); } diff --git a/source/dofs/dof_tools_sparsity.inst.in b/source/dofs/dof_tools_sparsity.inst.in index 5222635f7d..26ec4109a9 100644 --- a/source/dofs/dof_tools_sparsity.inst.in +++ b/source/dofs/dof_tools_sparsity.inst.in @@ -14,21 +14,21 @@ // --------------------------------------------------------------------- for (scalar: REAL_SCALARS; SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) - { +{ template void DoFTools::make_boundary_sparsity_pattern,SP,scalar> (const DoFHandler& dof, const std::map*> &boundary_ids, const std::vector &dof_to_boundary_mapping, SP &sparsity); - + template void DoFTools::make_boundary_sparsity_pattern,SP,scalar> (const hp::DoFHandler& dof, const std::map*> &boundary_ids, const std::vector &dof_to_boundary_mapping, SP &sparsity); - + #if deal_II_dimension < 3 template void DoFTools::make_boundary_sparsity_pattern,SP,scalar> @@ -36,7 +36,7 @@ for (scalar: REAL_SCALARS; SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSION const std::map*> &boundary_ids, const std::vector &dof_to_boundary_mapping, SP &sparsity); - + template void DoFTools::make_boundary_sparsity_pattern,SP,scalar> (const DoFHandler& dof, @@ -50,8 +50,8 @@ for (scalar: REAL_SCALARS; SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSION // const std::map*> &boundary_ids, // const std::vector &dof_to_boundary_mapping, // SP &sparsity); - -#endif + +#endif #if deal_II_dimension == 1 template void @@ -60,7 +60,7 @@ for (scalar: REAL_SCALARS; SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSION const std::map*> &boundary_ids, const std::vector &dof_to_boundary_mapping, SP &sparsity); - + template void DoFTools::make_boundary_sparsity_pattern,SP,scalar> (const DoFHandler& dof, @@ -68,25 +68,25 @@ for (scalar: REAL_SCALARS; SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSION const std::vector &dof_to_boundary_mapping, SP &sparsity); #endif - - } + +} for (scalar: COMPLEX_SCALARS; SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) - { +{ template void DoFTools::make_boundary_sparsity_pattern,SP,scalar> (const DoFHandler& dof, const std::map*> &boundary_ids, const std::vector &dof_to_boundary_mapping, SP &sparsity); - + template void DoFTools::make_boundary_sparsity_pattern,SP,scalar> (const hp::DoFHandler& dof, const std::map*> &boundary_ids, const std::vector &dof_to_boundary_mapping, SP &sparsity); - + #if deal_II_dimension < 3 template void DoFTools::make_boundary_sparsity_pattern,SP,scalar> @@ -94,7 +94,7 @@ for (scalar: COMPLEX_SCALARS; SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENS const std::map*> &boundary_ids, const std::vector &dof_to_boundary_mapping, SP &sparsity); - + template void DoFTools::make_boundary_sparsity_pattern,SP,scalar> (const DoFHandler& dof, @@ -108,13 +108,13 @@ for (scalar: COMPLEX_SCALARS; SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENS // const std::map*> &boundary_ids, // const std::vector &dof_to_boundary_mapping, // SP &sparsity); - -#endif - - } + +#endif + +} for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) - { +{ template void DoFTools::make_sparsity_pattern, SP> (const DoFHandler &dof, @@ -362,20 +362,20 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) #endif - } +} for (deal_II_dimension : DIMENSIONS) { - template - Table<2,DoFTools::Coupling> - DoFTools::dof_couplings_from_component_couplings - (const FiniteElement &fe, - const Table<2,DoFTools::Coupling> &component_couplings); - - template - std::vector > - DoFTools::dof_couplings_from_component_couplings - (const hp::FECollection &fe, - const Table<2,DoFTools::Coupling> &component_couplings); + template + Table<2,DoFTools::Coupling> + DoFTools::dof_couplings_from_component_couplings + (const FiniteElement &fe, + const Table<2,DoFTools::Coupling> &component_couplings); + + template + std::vector > + DoFTools::dof_couplings_from_component_couplings + (const hp::FECollection &fe, + const Table<2,DoFTools::Coupling> &component_couplings); } diff --git a/source/fe/fe.inst.in b/source/fe/fe.inst.in index 24d2c1c72f..09d011d67b 100644 --- a/source/fe/fe.inst.in +++ b/source/fe/fe.inst.in @@ -16,9 +16,9 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class FiniteElement; #endif - } +} diff --git a/source/fe/fe_abf.inst.in b/source/fe/fe_abf.inst.in index 2010ba16d7..1c7baa1dd6 100644 --- a/source/fe/fe_abf.inst.in +++ b/source/fe/fe_abf.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_ABF; - } +} diff --git a/source/fe/fe_bdm.inst.in b/source/fe/fe_bdm.inst.in index 411ef0d4c2..a949a32887 100644 --- a/source/fe/fe_bdm.inst.in +++ b/source/fe/fe_bdm.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_BDM; - } +} diff --git a/source/fe/fe_bernstein.inst.in b/source/fe/fe_bernstein.inst.in index cf1e23768f..19ee97d98b 100644 --- a/source/fe/fe_bernstein.inst.in +++ b/source/fe/fe_bernstein.inst.in @@ -16,8 +16,8 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { - #if deal_II_dimension <= deal_II_space_dimension - template class FE_Bernstein; - #endif - } +{ +#if deal_II_dimension <= deal_II_space_dimension + template class FE_Bernstein; +#endif +} diff --git a/source/fe/fe_dg_vector.inst.in b/source/fe/fe_dg_vector.inst.in index 2a81f9454e..e6da39d5bb 100644 --- a/source/fe/fe_dg_vector.inst.in +++ b/source/fe/fe_dg_vector.inst.in @@ -16,14 +16,14 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_DGVector, deal_II_dimension>; template class FE_DGVector, deal_II_dimension>; template class FE_DGVector, deal_II_dimension>; template class FE_DGVector, deal_II_dimension>; - + template class FE_DGNedelec; template class FE_DGRaviartThomas; template class FE_DGBDM; - } +} diff --git a/source/fe/fe_dgp.inst.in b/source/fe/fe_dgp.inst.in index e41e49e78c..412b8a4012 100644 --- a/source/fe/fe_dgp.inst.in +++ b/source/fe/fe_dgp.inst.in @@ -16,10 +16,10 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class FE_DGP; #endif - } +} diff --git a/source/fe/fe_dgp_monomial.inst.in b/source/fe/fe_dgp_monomial.inst.in index 79de6ae2c9..9e9764138b 100644 --- a/source/fe/fe_dgp_monomial.inst.in +++ b/source/fe/fe_dgp_monomial.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_DGPMonomial; - } +} diff --git a/source/fe/fe_dgp_nonparametric.inst.in b/source/fe/fe_dgp_nonparametric.inst.in index a38dc380f4..76def2a477 100644 --- a/source/fe/fe_dgp_nonparametric.inst.in +++ b/source/fe/fe_dgp_nonparametric.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_DGPNonparametric; - } +} diff --git a/source/fe/fe_dgq.inst.in b/source/fe/fe_dgq.inst.in index 7f556d4e89..27bee60a59 100644 --- a/source/fe/fe_dgq.inst.in +++ b/source/fe/fe_dgq.inst.in @@ -16,9 +16,9 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class FE_DGQ; template class FE_DGQArbitraryNodes; #endif - } +} diff --git a/source/fe/fe_face.inst.in b/source/fe/fe_face.inst.in index 9f42ca692a..be53820157 100644 --- a/source/fe/fe_face.inst.in +++ b/source/fe/fe_face.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ #if deal_II_dimension > 1 template class FE_PolyFace >; template class FE_PolyFace, deal_II_dimension>; @@ -24,5 +24,5 @@ for (deal_II_dimension : DIMENSIONS) #endif template class FE_FaceQ; template class FE_FaceP; - } +} diff --git a/source/fe/fe_nedelec.inst.in b/source/fe/fe_nedelec.inst.in index ae05b11ed0..1efd136977 100644 --- a/source/fe/fe_nedelec.inst.in +++ b/source/fe/fe_nedelec.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_Nedelec; - } +} diff --git a/source/fe/fe_nothing.inst.in b/source/fe/fe_nothing.inst.in index 6948f0f06b..5dd38bc6f7 100644 --- a/source/fe/fe_nothing.inst.in +++ b/source/fe/fe_nothing.inst.in @@ -16,9 +16,9 @@ for (deal_II_dimension, deal_II_space_dimension : DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class FE_Nothing; #endif - } +} diff --git a/source/fe/fe_poly.inst.in b/source/fe/fe_poly.inst.in index d9dd85373a..6ef0e86a65 100644 --- a/source/fe/fe_poly.inst.in +++ b/source/fe/fe_poly.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class FE_Poly, deal_II_dimension, deal_II_space_dimension>; template class FE_Poly, deal_II_dimension, deal_II_space_dimension>; @@ -26,5 +26,5 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS template class FE_Poly, deal_II_dimension, deal_II_space_dimension>; template class FE_Poly, deal_II_dimension, deal_II_space_dimension>; #endif - } +} diff --git a/source/fe/fe_poly_tensor.inst.in b/source/fe/fe_poly_tensor.inst.in index 807126de43..6bb2697e95 100644 --- a/source/fe/fe_poly_tensor.inst.in +++ b/source/fe/fe_poly_tensor.inst.in @@ -16,10 +16,10 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_PolyTensor,deal_II_dimension>; template class FE_PolyTensor,deal_II_dimension>; template class FE_PolyTensor,deal_II_dimension>; template class FE_PolyTensor, deal_II_dimension>; - } +} diff --git a/source/fe/fe_q.inst.in b/source/fe/fe_q.inst.in index 93ca7d1d74..12228f0fa6 100644 --- a/source/fe/fe_q.inst.in +++ b/source/fe/fe_q.inst.in @@ -16,10 +16,10 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class FE_Q; #endif - } +} diff --git a/source/fe/fe_q_base.inst.in b/source/fe/fe_q_base.inst.in index b67cf87cd8..9229a6d7bb 100644 --- a/source/fe/fe_q_base.inst.in +++ b/source/fe/fe_q_base.inst.in @@ -16,13 +16,13 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class FE_Q_Base, deal_II_dimension, deal_II_space_dimension>; template class FE_Q_Base, deal_II_dimension, deal_II_space_dimension>; template class FE_Q_Base, deal_II_dimension, deal_II_space_dimension>; template class FE_Q_Base >, deal_II_dimension, deal_II_space_dimension>; #endif - } +} diff --git a/source/fe/fe_q_bubbles.inst.in b/source/fe/fe_q_bubbles.inst.in index afbf2602a9..586391ea8f 100644 --- a/source/fe/fe_q_bubbles.inst.in +++ b/source/fe/fe_q_bubbles.inst.in @@ -17,8 +17,8 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class FE_Q_Bubbles; #endif - } +} diff --git a/source/fe/fe_q_dg0.inst.in b/source/fe/fe_q_dg0.inst.in index 3ab2cfd7a4..6f35ea2363 100644 --- a/source/fe/fe_q_dg0.inst.in +++ b/source/fe/fe_q_dg0.inst.in @@ -16,10 +16,10 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class FE_Q_DG0; #endif - } +} diff --git a/source/fe/fe_q_hierarchical.inst.in b/source/fe/fe_q_hierarchical.inst.in index 06f352989c..6bbaed2f19 100644 --- a/source/fe/fe_q_hierarchical.inst.in +++ b/source/fe/fe_q_hierarchical.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_Q_Hierarchical; - } +} diff --git a/source/fe/fe_q_iso_q1.inst.in b/source/fe/fe_q_iso_q1.inst.in index 7699e47956..4fa3379608 100644 --- a/source/fe/fe_q_iso_q1.inst.in +++ b/source/fe/fe_q_iso_q1.inst.in @@ -16,10 +16,10 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class FE_Q_iso_Q1; #endif - } +} diff --git a/source/fe/fe_rannacher_turek.inst.in b/source/fe/fe_rannacher_turek.inst.in index 5c165e24bd..24d63dfc95 100644 --- a/source/fe/fe_rannacher_turek.inst.in +++ b/source/fe/fe_rannacher_turek.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_RannacherTurek; - } +} diff --git a/source/fe/fe_raviart_thomas.inst.in b/source/fe/fe_raviart_thomas.inst.in index 9a92cde2df..8d7b831f53 100644 --- a/source/fe/fe_raviart_thomas.inst.in +++ b/source/fe/fe_raviart_thomas.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_RaviartThomas; - } +} diff --git a/source/fe/fe_raviart_thomas_nodal.inst.in b/source/fe/fe_raviart_thomas_nodal.inst.in index c546410b5e..9e9e5b8d55 100644 --- a/source/fe/fe_raviart_thomas_nodal.inst.in +++ b/source/fe/fe_raviart_thomas_nodal.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_RaviartThomasNodal; - } +} diff --git a/source/fe/fe_system.inst.in b/source/fe/fe_system.inst.in index ccda2dc457..ec29bcd692 100644 --- a/source/fe/fe_system.inst.in +++ b/source/fe/fe_system.inst.in @@ -15,10 +15,10 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class FESystem; #endif - } - +} + diff --git a/source/fe/fe_tools.inst.in b/source/fe/fe_tools.inst.in index b87a95e25f..c3b04be5d9 100644 --- a/source/fe/fe_tools.inst.in +++ b/source/fe/fe_tools.inst.in @@ -15,103 +15,103 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ namespace FETools \{ #if deal_II_dimension <= deal_II_space_dimension - namespace Compositing - \{ - template - FiniteElementData - multiply_dof_numbers (const std::vector*> &fes, - const std::vector &multiplicities, - bool); - - template - FiniteElementData - multiply_dof_numbers (const FiniteElement *fe1, - const unsigned int N1, - const FiniteElement *fe2, - const unsigned int N2, - const FiniteElement *fe3, - const unsigned int N3, - const FiniteElement *fe4, - const unsigned int N4, - const FiniteElement *fe5, - const unsigned int N5); - - template - std::vector - compute_restriction_is_additive_flags (const std::vector*> &fes, - const std::vector &multiplicities); - - template - std::vector - compute_restriction_is_additive_flags (const FiniteElement *fe1, - const unsigned int N1, - const FiniteElement *fe2, - const unsigned int N2, - const FiniteElement *fe3, - const unsigned int N3, - const FiniteElement *fe4, - const unsigned int N4, - const FiniteElement *fe5, - const unsigned int N5); - - template - std::vector - compute_nonzero_components (const std::vector*> &fes, - const std::vector &multiplicities, - const bool do_tensor_product); - - template - std::vector - compute_nonzero_components (const FiniteElement *fe1, - const unsigned int N1, - const FiniteElement *fe2, - const unsigned int N2, - const FiniteElement *fe3, - const unsigned int N3, - const FiniteElement *fe4, - const unsigned int N4, - const FiniteElement *fe5, - const unsigned int N5, - const bool); - - template - void - build_cell_tables(std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > &system_to_base_table, - std::vector< std::pair< unsigned int, unsigned int > > &system_to_component_table, - std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > &component_to_base_table, - const FiniteElement &fe, - const bool do_tensor_product); - - template - void - build_face_tables(std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > &face_system_to_base_table, - std::vector< std::pair< unsigned int, unsigned int > > &face_system_to_component_table, - const FiniteElement &fe, - const bool do_tensor_product); - - \} - - template - void compute_block_renumbering ( + namespace Compositing + \{ + template + FiniteElementData + multiply_dof_numbers (const std::vector*> &fes, + const std::vector &multiplicities, + bool); + + template + FiniteElementData + multiply_dof_numbers (const FiniteElement *fe1, + const unsigned int N1, + const FiniteElement *fe2, + const unsigned int N2, + const FiniteElement *fe3, + const unsigned int N3, + const FiniteElement *fe4, + const unsigned int N4, + const FiniteElement *fe5, + const unsigned int N5); + + template + std::vector + compute_restriction_is_additive_flags (const std::vector*> &fes, + const std::vector &multiplicities); + + template + std::vector + compute_restriction_is_additive_flags (const FiniteElement *fe1, + const unsigned int N1, + const FiniteElement *fe2, + const unsigned int N2, + const FiniteElement *fe3, + const unsigned int N3, + const FiniteElement *fe4, + const unsigned int N4, + const FiniteElement *fe5, + const unsigned int N5); + + template + std::vector + compute_nonzero_components (const std::vector*> &fes, + const std::vector &multiplicities, + const bool do_tensor_product); + + template + std::vector + compute_nonzero_components (const FiniteElement *fe1, + const unsigned int N1, + const FiniteElement *fe2, + const unsigned int N2, + const FiniteElement *fe3, + const unsigned int N3, + const FiniteElement *fe4, + const unsigned int N4, + const FiniteElement *fe5, + const unsigned int N5, + const bool); + + template + void + build_cell_tables(std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > &system_to_base_table, + std::vector< std::pair< unsigned int, unsigned int > > &system_to_component_table, + std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > &component_to_base_table, + const FiniteElement &fe, + const bool do_tensor_product); + + template + void + build_face_tables(std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > &face_system_to_base_table, + std::vector< std::pair< unsigned int, unsigned int > > &face_system_to_component_table, + const FiniteElement &fe, + const bool do_tensor_product); + + \} + + template + void compute_block_renumbering ( const FiniteElement & , std::vector &, std::vector &, bool); - template - void compute_projection_matrices - (const FiniteElement &, - std::vector > > &, bool); + template + void compute_projection_matrices + (const FiniteElement &, + std::vector > > &, bool); - template - void compute_embedding_matrices - (const FiniteElement &, - std::vector > > &, const bool, const double); + template + void compute_embedding_matrices + (const FiniteElement &, + std::vector > > &, const bool, const double); #endif - \} - } + \} +} @@ -119,143 +119,143 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS // where applicable and move to codimension cases above also when applicable for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ namespace FETools - \{ + \{ #if deal_II_dimension <= deal_II_space_dimension - template - void get_interpolation_matrix - (const FiniteElement &, - const FiniteElement &, - FullMatrix &); + template + void get_interpolation_matrix + (const FiniteElement &, + const FiniteElement &, + FullMatrix &); - template FiniteElement * - get_fe_by_name (const std::string &); + template FiniteElement * + get_fe_by_name (const std::string &); #endif #if deal_II_dimension == deal_II_space_dimension - template class FEFactoryBase; + template class FEFactoryBase; - template FiniteElement * - get_fe_from_name (const std::string &); + template FiniteElement * + get_fe_from_name (const std::string &); - template - void compute_node_matrix( + template + void compute_node_matrix( FullMatrix &, const FiniteElement &); - template - void compute_component_wise( + template + void compute_component_wise( const FiniteElement & , std::vector &, std::vector > &); - template - void get_back_interpolation_matrix - (const FiniteElement &, - const FiniteElement &, - FullMatrix &); - template - void get_interpolation_difference_matrix - (const FiniteElement &, - const FiniteElement &, - FullMatrix &); - template - void get_interpolation_matrix - (const FiniteElement &, - const FiniteElement &, - FullMatrix &); - template - void get_back_interpolation_matrix - (const FiniteElement &, - const FiniteElement &, - FullMatrix &); - template - void get_interpolation_difference_matrix - (const FiniteElement &, - const FiniteElement &, - FullMatrix &); - - template - void get_projection_matrix - (const FiniteElement &, - const FiniteElement &, - FullMatrix &); - - template - void compute_face_embedding_matrices - (const FiniteElement &, FullMatrix ( &)[GeometryInfo::max_children_per_face], - unsigned int, unsigned int, const double); - - template - void - compute_projection_from_quadrature_points_matrix (const FiniteElement &, - const Quadrature &, - const Quadrature &, - FullMatrix &); - - template - void - compute_projection_from_quadrature_points( + template + void get_back_interpolation_matrix + (const FiniteElement &, + const FiniteElement &, + FullMatrix &); + template + void get_interpolation_difference_matrix + (const FiniteElement &, + const FiniteElement &, + FullMatrix &); + template + void get_interpolation_matrix + (const FiniteElement &, + const FiniteElement &, + FullMatrix &); + template + void get_back_interpolation_matrix + (const FiniteElement &, + const FiniteElement &, + FullMatrix &); + template + void get_interpolation_difference_matrix + (const FiniteElement &, + const FiniteElement &, + FullMatrix &); + + template + void get_projection_matrix + (const FiniteElement &, + const FiniteElement &, + FullMatrix &); + + template + void compute_face_embedding_matrices + (const FiniteElement &, FullMatrix ( &)[GeometryInfo::max_children_per_face], + unsigned int, unsigned int, const double); + + template + void + compute_projection_from_quadrature_points_matrix (const FiniteElement &, + const Quadrature &, + const Quadrature &, + FullMatrix &); + + template + void + compute_projection_from_quadrature_points( const FullMatrix &, const std::vector< Tensor<1, deal_II_dimension > > &, std::vector< Tensor<1, deal_II_dimension > > &); - template - void - compute_projection_from_quadrature_points( + template + void + compute_projection_from_quadrature_points( const FullMatrix &, const std::vector > &, std::vector > &); - template - void - compute_interpolation_to_quadrature_points_matrix (const FiniteElement &, - const Quadrature &, - FullMatrix &); + template + void + compute_interpolation_to_quadrature_points_matrix (const FiniteElement &, + const Quadrature &, + FullMatrix &); #if deal_II_dimension != 1 - template - void - compute_projection_from_face_quadrature_points_matrix (const FiniteElement &, - const Quadrature &, - const Quadrature &, - const DoFHandler::active_cell_iterator & , - unsigned int, - FullMatrix &); + template + void + compute_projection_from_face_quadrature_points_matrix (const FiniteElement &, + const Quadrature &, + const Quadrature &, + const DoFHandler::active_cell_iterator & , + unsigned int, + FullMatrix &); #endif - template - void - hierarchic_to_lexicographic_numbering - (unsigned int, - std::vector &); - - template - void - hierarchic_to_lexicographic_numbering - (const FiniteElementData &, - std::vector &); - - template - void - lexicographic_to_hierarchic_numbering - (const FiniteElementData &, - std::vector &); - - template - std::vector - hierarchic_to_lexicographic_numbering - (const FiniteElementData &); - - template - std::vector - lexicographic_to_hierarchic_numbering - (const FiniteElementData &); + template + void + hierarchic_to_lexicographic_numbering + (unsigned int, + std::vector &); + + template + void + hierarchic_to_lexicographic_numbering + (const FiniteElementData &, + std::vector &); + + template + void + lexicographic_to_hierarchic_numbering + (const FiniteElementData &, + std::vector &); + + template + std::vector + hierarchic_to_lexicographic_numbering + (const FiniteElementData &); + + template + std::vector + lexicographic_to_hierarchic_numbering + (const FiniteElementData &); #endif - \} - } + \} +} diff --git a/source/fe/fe_tools_interpolate.inst.in b/source/fe/fe_tools_interpolate.inst.in index d88909bc70..08b6654304 100644 --- a/source/fe/fe_tools_interpolate.inst.in +++ b/source/fe/fe_tools_interpolate.inst.in @@ -16,91 +16,91 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; Vector : SERIAL_VECTORS) - { +{ namespace FETools - \{ + \{ #if deal_II_dimension <= deal_II_space_dimension - template - void interpolate - (const DoFHandler &, const Vector &, - const DoFHandler &, Vector &); + template + void interpolate + (const DoFHandler &, const Vector &, + const DoFHandler &, Vector &); - template - void interpolate - (const DoFHandler &, const Vector &, - const DoFHandler &, const ConstraintMatrix &, - Vector &); + template + void interpolate + (const DoFHandler &, const Vector &, + const DoFHandler &, const ConstraintMatrix &, + Vector &); #endif - \} - } + \} +} for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ namespace FETools - \{ + \{ #if deal_II_dimension == deal_II_space_dimension - template - void interpolate - (const hp::DoFHandler &, const Vector &, - const hp::DoFHandler &, Vector &); - template - void interpolate - (const hp::DoFHandler &, const Vector &, - const hp::DoFHandler &, const ConstraintMatrix &, - Vector &); - template - void interpolate - (const hp::DoFHandler &, const Vector &, - const hp::DoFHandler &, Vector &); - template - void interpolate - (const hp::DoFHandler &, const Vector &, - const hp::DoFHandler &, const ConstraintMatrix &, - Vector &); + template + void interpolate + (const hp::DoFHandler &, const Vector &, + const hp::DoFHandler &, Vector &); + template + void interpolate + (const hp::DoFHandler &, const Vector &, + const hp::DoFHandler &, const ConstraintMatrix &, + Vector &); + template + void interpolate + (const hp::DoFHandler &, const Vector &, + const hp::DoFHandler &, Vector &); + template + void interpolate + (const hp::DoFHandler &, const Vector &, + const hp::DoFHandler &, const ConstraintMatrix &, + Vector &); #endif - \} - } + \} +} for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; VEC : SERIAL_VECTORS) - { +{ namespace FETools - \{ + \{ #if deal_II_dimension == deal_II_space_dimension - template - void back_interpolate - (const DoFHandler &, const VEC &, - const FiniteElement &, VEC &); - template - void back_interpolate - (const DoFHandler &, const ConstraintMatrix &, - const VEC &, - const DoFHandler &, const ConstraintMatrix &, - VEC &); - template - void interpolation_difference - (const DoFHandler &, const VEC &, - const FiniteElement &, VEC &); - template - void interpolation_difference - (const DoFHandler &, const ConstraintMatrix &, - const VEC &, - const DoFHandler &, const ConstraintMatrix &, - VEC &); - template - void project_dg - (const DoFHandler &, const VEC &, - const DoFHandler &, VEC &); - template - void extrapolate - (const DoFHandler &, const VEC &, - const DoFHandler &, VEC &); - template - void extrapolate - (const DoFHandler &, const VEC &, - const DoFHandler &, const ConstraintMatrix &, - VEC &); + template + void back_interpolate + (const DoFHandler &, const VEC &, + const FiniteElement &, VEC &); + template + void back_interpolate + (const DoFHandler &, const ConstraintMatrix &, + const VEC &, + const DoFHandler &, const ConstraintMatrix &, + VEC &); + template + void interpolation_difference + (const DoFHandler &, const VEC &, + const FiniteElement &, VEC &); + template + void interpolation_difference + (const DoFHandler &, const ConstraintMatrix &, + const VEC &, + const DoFHandler &, const ConstraintMatrix &, + VEC &); + template + void project_dg + (const DoFHandler &, const VEC &, + const DoFHandler &, VEC &); + template + void extrapolate + (const DoFHandler &, const VEC &, + const DoFHandler &, VEC &); + template + void extrapolate + (const DoFHandler &, const VEC &, + const DoFHandler &, const ConstraintMatrix &, + VEC &); #endif - \} - } + \} +} diff --git a/source/fe/fe_trace.inst.in b/source/fe/fe_trace.inst.in index 22aaa5a6aa..1e24f4b37e 100644 --- a/source/fe/fe_trace.inst.in +++ b/source/fe/fe_trace.inst.in @@ -14,6 +14,6 @@ // --------------------------------------------------------------------- for (deal_II_dimension : DIMENSIONS) - { +{ template class FE_TraceQ; - } +} diff --git a/source/fe/fe_values.decl.1.inst.in b/source/fe/fe_values.decl.1.inst.in index 30129eb20a..ee05b07c64 100644 --- a/source/fe/fe_values.decl.1.inst.in +++ b/source/fe/fe_values.decl.1.inst.in @@ -19,13 +19,13 @@ // and derived classes for (VEC : SERIAL_VECTORS) - { - /// Call - /// @p get_interpolated_dof_values - /// of the iterator with the - /// given arguments. +{ + /// Call + /// @p get_interpolated_dof_values + /// of the iterator with the + /// given arguments. virtual void get_interpolated_dof_values (const VEC &in, - Vector &out) const = 0; - } + Vector &out) const = 0; +} diff --git a/source/fe/fe_values.decl.2.inst.in b/source/fe/fe_values.decl.2.inst.in index 9a91f9830f..75742db88c 100644 --- a/source/fe/fe_values.decl.2.inst.in +++ b/source/fe/fe_values.decl.2.inst.in @@ -19,13 +19,13 @@ // and derived classes for (VEC : SERIAL_VECTORS) - { - /// Call - /// @p get_interpolated_dof_values - /// of the iterator with the - /// given arguments. +{ + /// Call + /// @p get_interpolated_dof_values + /// of the iterator with the + /// given arguments. virtual void get_interpolated_dof_values (const VEC &in, - Vector &out) const; - } + Vector &out) const; +} diff --git a/source/fe/fe_values.impl.1.inst.in b/source/fe/fe_values.impl.1.inst.in index 7dbdc341cf..b95814a905 100644 --- a/source/fe/fe_values.impl.1.inst.in +++ b/source/fe/fe_values.impl.1.inst.in @@ -15,14 +15,14 @@ for (VEC : SERIAL_VECTORS) - { +{ template template void FEValuesBase::CellIterator:: get_interpolated_dof_values (const VEC &in, - Vector &out) const - \{ - cell->get_interpolated_dof_values (in, out); + Vector &out) const + { // + cell->get_interpolated_dof_values (in, out); \} - } +} diff --git a/source/fe/fe_values.impl.2.inst.in b/source/fe/fe_values.impl.2.inst.in index 5aa37dbc4d..0f4a16b3d3 100644 --- a/source/fe/fe_values.impl.2.inst.in +++ b/source/fe/fe_values.impl.2.inst.in @@ -15,13 +15,13 @@ for (VEC : SERIAL_VECTORS) - { +{ template void FEValuesBase::TriaCellIterator:: get_interpolated_dof_values (const VEC &, - Vector &) const - \{ - Assert (false, ExcMessage (message_string)); + Vector &) const + { // + Assert (false, ExcMessage (message_string)); \} - } +} diff --git a/source/fe/fe_values.inst.in b/source/fe/fe_values.inst.in index e4842ec21e..54443bef93 100644 --- a/source/fe/fe_values.inst.in +++ b/source/fe/fe_values.inst.in @@ -19,12 +19,12 @@ // FEValuesViews::Vector). for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class FEValuesBase; template class FEValues; template class FEValuesBase:: - CellIterator::cell_iterator>; + CellIterator::cell_iterator>; template class FEFaceValuesBase; template class FEFaceValues; @@ -32,265 +32,265 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS namespace FEValuesViews - \{ - template class Scalar; - template class Vector; - template class SymmetricTensor<2, deal_II_dimension, deal_II_space_dimension>; - template class Tensor<2, deal_II_dimension, deal_II_space_dimension>; - \} + \{ + template class Scalar; + template class Vector; + template class SymmetricTensor<2, deal_II_dimension, deal_II_space_dimension>; + template class Tensor<2, deal_II_dimension, deal_II_space_dimension>; + \} #endif - } +} for (dof_handler : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; lda : BOOL) - { +{ #if deal_II_dimension <= deal_II_space_dimension template void FEValues::reinit( - const TriaIterator, lda> >&); + const TriaIterator, lda> >&); template void FEFaceValues::reinit( - const TriaIterator, lda> >&, unsigned int); + const TriaIterator, lda> >&, unsigned int); template void FESubfaceValues::reinit( - const TriaIterator, lda> >&, unsigned int, unsigned int); + const TriaIterator, lda> >&, unsigned int, unsigned int); #endif - } +} for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template - void FEValuesViews::Scalar - ::get_function_values - (const dealii::VEC&, std::vector::type>&) const; + void FEValuesViews::Scalar + ::get_function_values + (const dealii::VEC&, std::vector::type>&) const; template - void FEValuesViews::Scalar - ::get_function_gradients - (const dealii::VEC&, std::vector >::type>&) const; + void FEValuesViews::Scalar + ::get_function_gradients + (const dealii::VEC&, std::vector >::type>&) const; template - void FEValuesViews::Scalar - ::get_function_hessians - (const dealii::VEC&, std::vector >::type>&) const; + void FEValuesViews::Scalar + ::get_function_hessians + (const dealii::VEC&, std::vector >::type>&) const; template - void FEValuesViews::Scalar - ::get_function_laplacians - (const dealii::VEC&, std::vector::type> &) const; + void FEValuesViews::Scalar + ::get_function_laplacians + (const dealii::VEC&, std::vector::type> &) const; template - void FEValuesViews::Scalar - ::get_function_third_derivatives - (const dealii::VEC&, std::vector >::type>&) const; + void FEValuesViews::Scalar + ::get_function_third_derivatives + (const dealii::VEC&, std::vector >::type>&) const; template - void FEValuesViews::Vector - ::get_function_values - (const dealii::VEC&, std::vector >::type >&) const; + void FEValuesViews::Vector + ::get_function_values + (const dealii::VEC&, std::vector >::type >&) const; template - void FEValuesViews::Vector - ::get_function_gradients - (const dealii::VEC&, std::vector >::type >&) const; + void FEValuesViews::Vector + ::get_function_gradients + (const dealii::VEC&, std::vector >::type >&) const; template - void FEValuesViews::Vector - ::get_function_symmetric_gradients - (const dealii::VEC&, std::vector >::type >&) const; + void FEValuesViews::Vector + ::get_function_symmetric_gradients + (const dealii::VEC&, std::vector >::type >&) const; template - void FEValuesViews::Vector - ::get_function_curls - (const dealii::VEC&, std::vector::type>&) const; + void FEValuesViews::Vector + ::get_function_curls + (const dealii::VEC&, std::vector::type>&) const; template - void FEValuesViews::Vector - ::get_function_divergences - (const dealii::VEC&, std::vector::type>&) const; + void FEValuesViews::Vector + ::get_function_divergences + (const dealii::VEC&, std::vector::type>&) const; template - void FEValuesViews::Vector - ::get_function_hessians - (const dealii::VEC&, std::vector >::type >&) const; + void FEValuesViews::Vector + ::get_function_hessians + (const dealii::VEC&, std::vector >::type >&) const; template - void FEValuesViews::Vector - ::get_function_laplacians - (const dealii::VEC&, std::vector >::type >&) const; + void FEValuesViews::Vector + ::get_function_laplacians + (const dealii::VEC&, std::vector >::type >&) const; template - void FEValuesViews::Vector - ::get_function_third_derivatives - (const dealii::VEC&, std::vector >::type >&) const; + void FEValuesViews::Vector + ::get_function_third_derivatives + (const dealii::VEC&, std::vector >::type >&) const; template - void FEValuesViews::SymmetricTensor<2, deal_II_dimension, deal_II_space_dimension> - ::get_function_values - (const dealii::VEC&, std::vector >::type>&) const; + void FEValuesViews::SymmetricTensor<2, deal_II_dimension, deal_II_space_dimension> + ::get_function_values + (const dealii::VEC&, std::vector >::type>&) const; template - void FEValuesViews::SymmetricTensor<2, deal_II_dimension, deal_II_space_dimension> - ::get_function_divergences - (const dealii::VEC&, std::vector >::type>&) const; + void FEValuesViews::SymmetricTensor<2, deal_II_dimension, deal_II_space_dimension> + ::get_function_divergences + (const dealii::VEC&, std::vector >::type>&) const; template - void FEValuesViews::Tensor<2, deal_II_dimension, deal_II_space_dimension> - ::get_function_values - (const dealii::VEC&, std::vector >::type>&) const; + void FEValuesViews::Tensor<2, deal_II_dimension, deal_II_space_dimension> + ::get_function_values + (const dealii::VEC&, std::vector >::type>&) const; template - void FEValuesViews::Tensor<2, deal_II_dimension, deal_II_space_dimension> - ::get_function_divergences - (const dealii::VEC&, std::vector >::type>&) const; + void FEValuesViews::Tensor<2, deal_II_dimension, deal_II_space_dimension> + ::get_function_divergences + (const dealii::VEC&, std::vector >::type>&) const; #endif - } +} for (VEC : SERIAL_VECTORS; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template - void FEValuesBase::get_function_values - (const VEC&, std::vector&) const; + void FEValuesBase::get_function_values + (const VEC&, std::vector&) const; template - void FEValuesBase::get_function_values - (const VEC&, const VectorSlice >&, std::vector&) const; + void FEValuesBase::get_function_values + (const VEC&, const VectorSlice >&, std::vector&) const; template - void FEValuesBase::get_function_values - (const VEC&, std::vector > &) const; + void FEValuesBase::get_function_values + (const VEC&, std::vector > &) const; template - void FEValuesBase::get_function_values - (const VEC&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_values + (const VEC&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_values - (const VEC&, const VectorSlice >&, - VectorSlice > >, bool) const; + void FEValuesBase::get_function_values + (const VEC&, const VectorSlice >&, + VectorSlice > >, bool) const; template - void FEValuesBase::get_function_gradients - (const VEC&, std::vector > &) const; + void FEValuesBase::get_function_gradients + (const VEC&, std::vector > &) const; template - void FEValuesBase::get_function_gradients - (const VEC&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_gradients + (const VEC&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_gradients - (const VEC&, std::vector > > &) const; + void FEValuesBase::get_function_gradients + (const VEC&, std::vector > > &) const; template - void FEValuesBase::get_function_gradients - (const VEC&, const VectorSlice >&, - VectorSlice > > >, bool) const; + void FEValuesBase::get_function_gradients + (const VEC&, const VectorSlice >&, + VectorSlice > > >, bool) const; template - void FEValuesBase::get_function_hessians - (const VEC&, std::vector > &) const; + void FEValuesBase::get_function_hessians + (const VEC&, std::vector > &) const; template - void FEValuesBase::get_function_hessians - (const VEC&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_hessians + (const VEC&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_hessians - (const VEC&, std::vector > > &, bool) const; + void FEValuesBase::get_function_hessians + (const VEC&, std::vector > > &, bool) const; template - void FEValuesBase::get_function_hessians - (const VEC&, const VectorSlice >&, - VectorSlice > > >, bool) const; + void FEValuesBase::get_function_hessians + (const VEC&, const VectorSlice >&, + VectorSlice > > >, bool) const; template - void FEValuesBase::get_function_laplacians - (const VEC&, std::vector&) const; + void FEValuesBase::get_function_laplacians + (const VEC&, std::vector&) const; template - void FEValuesBase::get_function_laplacians - (const VEC&, const VectorSlice >&, std::vector&) const; + void FEValuesBase::get_function_laplacians + (const VEC&, const VectorSlice >&, std::vector&) const; template - void FEValuesBase::get_function_laplacians - (const VEC&, std::vector > &) const; + void FEValuesBase::get_function_laplacians + (const VEC&, std::vector > &) const; template - void FEValuesBase::get_function_laplacians - (const VEC&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_laplacians + (const VEC&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_laplacians - (const VEC&, const VectorSlice >&, - std::vector > &, bool) const; - + void FEValuesBase::get_function_laplacians + (const VEC&, const VectorSlice >&, + std::vector > &, bool) const; + template - void FEValuesBase::get_function_third_derivatives - (const VEC&, std::vector > &) const; + void FEValuesBase::get_function_third_derivatives + (const VEC&, std::vector > &) const; template - void FEValuesBase::get_function_third_derivatives - (const VEC&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_third_derivatives + (const VEC&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_third_derivatives - (const VEC&, std::vector > > &, bool) const; + void FEValuesBase::get_function_third_derivatives + (const VEC&, std::vector > > &, bool) const; template - void FEValuesBase::get_function_third_derivatives - (const VEC&, const VectorSlice >&, - VectorSlice > > >, bool) const; + void FEValuesBase::get_function_third_derivatives + (const VEC&, const VectorSlice >&, + VectorSlice > > >, bool) const; #endif - } +} // instantiations for VEC=IndexSet for (deal_II_dimension : DIMENSIONS) - { +{ template - void FEValuesViews::Scalar::get_function_values - (const dealii::IndexSet&, std::vector::type> &) const; + void FEValuesViews::Scalar::get_function_values + (const dealii::IndexSet&, std::vector::type> &) const; template - void FEValuesViews::Scalar::get_function_gradients - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Scalar::get_function_gradients + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::Scalar::get_function_hessians - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Scalar::get_function_hessians + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::Scalar::get_function_laplacians - (const dealii::IndexSet&, std::vector::type>&) const; + void FEValuesViews::Scalar::get_function_laplacians + (const dealii::IndexSet&, std::vector::type>&) const; template - void FEValuesViews::Scalar::get_function_third_derivatives - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Scalar::get_function_third_derivatives + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::Vector::get_function_values - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Vector::get_function_values + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::Vector::get_function_gradients - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Vector::get_function_gradients + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::Vector::get_function_symmetric_gradients - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Vector::get_function_symmetric_gradients + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::Vector::get_function_curls - (const dealii::IndexSet&, std::vector::type>&) const; + void FEValuesViews::Vector::get_function_curls + (const dealii::IndexSet&, std::vector::type>&) const; template - void FEValuesViews::Vector::get_function_divergences - (const dealii::IndexSet&, std::vector::type>&) const; + void FEValuesViews::Vector::get_function_divergences + (const dealii::IndexSet&, std::vector::type>&) const; template - void FEValuesViews::Vector::get_function_hessians - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Vector::get_function_hessians + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::Vector::get_function_laplacians - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Vector::get_function_laplacians + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::Vector::get_function_third_derivatives - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Vector::get_function_third_derivatives + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::SymmetricTensor<2,deal_II_dimension,deal_II_dimension>::get_function_values - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::SymmetricTensor<2,deal_II_dimension,deal_II_dimension>::get_function_values + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::SymmetricTensor<2,deal_II_dimension,deal_II_dimension>::get_function_divergences - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::SymmetricTensor<2,deal_II_dimension,deal_II_dimension>::get_function_divergences + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::Tensor<2,deal_II_dimension,deal_II_dimension>::get_function_values - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Tensor<2,deal_II_dimension,deal_II_dimension>::get_function_values + (const dealii::IndexSet&, std::vector >::type>&) const; template - void FEValuesViews::Tensor<2,deal_II_dimension,deal_II_dimension>::get_function_divergences - (const dealii::IndexSet&, std::vector >::type>&) const; + void FEValuesViews::Tensor<2,deal_II_dimension,deal_II_dimension>::get_function_divergences + (const dealii::IndexSet&, std::vector >::type>&) const; #if deal_II_dimension != 3 @@ -346,213 +346,213 @@ for (deal_II_dimension : DIMENSIONS) template void FEValuesViews::SymmetricTensor<2, deal_II_dimension, deal_II_dimension+1> - ::get_function_values + ::get_function_values (const dealii::IndexSet&, std::vector >::type>&) const; template void FEValuesViews::SymmetricTensor<2, deal_II_dimension, deal_II_dimension+1> - ::get_function_divergences + ::get_function_divergences (const dealii::IndexSet&, std::vector >::type>&) const; template void FEValuesViews::Tensor<2, deal_II_dimension, deal_II_dimension+1> - ::get_function_values + ::get_function_values (const dealii::IndexSet&, std::vector >::type>&) const; template void FEValuesViews::Tensor<2, deal_II_dimension, deal_II_dimension+1> - ::get_function_divergences + ::get_function_divergences (const dealii::IndexSet&, std::vector >::type>&) const; #endif - } +} // Instantiations of functions in FEValuesBase and IndexSet=IndexSet for (deal_II_dimension : DIMENSIONS) - { +{ template void FEValuesBase::get_function_values - (const IndexSet&, std::vector&) const; + (const IndexSet&, std::vector&) const; template - void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, std::vector&) const; + void FEValuesBase::get_function_values + (const IndexSet&, const VectorSlice >&, std::vector&) const; template - void FEValuesBase::get_function_values - (const IndexSet&, std::vector > &) const; + void FEValuesBase::get_function_values + (const IndexSet&, std::vector > &) const; template - void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_values + (const IndexSet&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, - VectorSlice > >, bool) const; + void FEValuesBase::get_function_values + (const IndexSet&, const VectorSlice >&, + VectorSlice > >, bool) const; template - void FEValuesBase::get_function_gradients - (const IndexSet&, std::vector > &) const; + void FEValuesBase::get_function_gradients + (const IndexSet&, std::vector > &) const; template - void FEValuesBase::get_function_gradients - (const IndexSet&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_gradients + (const IndexSet&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_gradients - (const IndexSet&, std::vector > > &) const; + void FEValuesBase::get_function_gradients + (const IndexSet&, std::vector > > &) const; template - void FEValuesBase::get_function_gradients - (const IndexSet&, const VectorSlice >&, - VectorSlice > > >, bool) const; + void FEValuesBase::get_function_gradients + (const IndexSet&, const VectorSlice >&, + VectorSlice > > >, bool) const; template - void FEValuesBase::get_function_hessians - (const IndexSet&, std::vector > &) const; + void FEValuesBase::get_function_hessians + (const IndexSet&, std::vector > &) const; template - void FEValuesBase::get_function_hessians - (const IndexSet&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_hessians + (const IndexSet&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_hessians - (const IndexSet&, std::vector > > &, bool) const; + void FEValuesBase::get_function_hessians + (const IndexSet&, std::vector > > &, bool) const; template - void FEValuesBase::get_function_hessians - (const IndexSet&, const VectorSlice >&, - VectorSlice > > >, bool) const; + void FEValuesBase::get_function_hessians + (const IndexSet&, const VectorSlice >&, + VectorSlice > > >, bool) const; template void FEValuesBase::get_function_laplacians - (const IndexSet&, std::vector&) const; + (const IndexSet&, std::vector&) const; template - void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, std::vector&) const; + void FEValuesBase::get_function_laplacians + (const IndexSet&, const VectorSlice >&, std::vector&) const; template - void FEValuesBase::get_function_laplacians - (const IndexSet&, std::vector > &) const; + void FEValuesBase::get_function_laplacians + (const IndexSet&, std::vector > &) const; template - void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_laplacians + (const IndexSet&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, - std::vector > &, bool) const; + void FEValuesBase::get_function_laplacians + (const IndexSet&, const VectorSlice >&, + std::vector > &, bool) const; template - void FEValuesBase::get_function_third_derivatives - (const IndexSet&, std::vector > &) const; + void FEValuesBase::get_function_third_derivatives + (const IndexSet&, std::vector > &) const; template - void FEValuesBase::get_function_third_derivatives - (const IndexSet&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_third_derivatives + (const IndexSet&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_third_derivatives - (const IndexSet&, std::vector > > &, bool) const; + void FEValuesBase::get_function_third_derivatives + (const IndexSet&, std::vector > > &, bool) const; template - void FEValuesBase::get_function_third_derivatives - (const IndexSet&, const VectorSlice >&, - VectorSlice > > >, bool) const; + void FEValuesBase::get_function_third_derivatives + (const IndexSet&, const VectorSlice >&, + VectorSlice > > >, bool) const; #if deal_II_dimension != 3 template void FEValuesBase::get_function_values - (const IndexSet&, std::vector&) const; + (const IndexSet&, std::vector&) const; template - void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, std::vector&) const; + void FEValuesBase::get_function_values + (const IndexSet&, const VectorSlice >&, std::vector&) const; template - void FEValuesBase::get_function_values - (const IndexSet&, std::vector > &) const; + void FEValuesBase::get_function_values + (const IndexSet&, std::vector > &) const; template - void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_values + (const IndexSet&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_values - (const IndexSet&, const VectorSlice >&, - VectorSlice > >, bool) const; + void FEValuesBase::get_function_values + (const IndexSet&, const VectorSlice >&, + VectorSlice > >, bool) const; template - void FEValuesBase::get_function_gradients - (const IndexSet&, std::vector > &) const; + void FEValuesBase::get_function_gradients + (const IndexSet&, std::vector > &) const; template - void FEValuesBase::get_function_gradients - (const IndexSet&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_gradients + (const IndexSet&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_gradients - (const IndexSet&, std::vector > > &) const; + void FEValuesBase::get_function_gradients + (const IndexSet&, std::vector > > &) const; template - void FEValuesBase::get_function_gradients - (const IndexSet&, const VectorSlice >&, - VectorSlice > > >, bool) const; + void FEValuesBase::get_function_gradients + (const IndexSet&, const VectorSlice >&, + VectorSlice > > >, bool) const; template - void FEValuesBase::get_function_hessians - (const IndexSet&, std::vector > &) const; + void FEValuesBase::get_function_hessians + (const IndexSet&, std::vector > &) const; template - void FEValuesBase::get_function_hessians - (const IndexSet&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_hessians + (const IndexSet&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_hessians - (const IndexSet&, std::vector > > &, bool) const; + void FEValuesBase::get_function_hessians + (const IndexSet&, std::vector > > &, bool) const; template - void FEValuesBase::get_function_hessians - (const IndexSet&, const VectorSlice >&, - VectorSlice > > >, bool) const; + void FEValuesBase::get_function_hessians + (const IndexSet&, const VectorSlice >&, + VectorSlice > > >, bool) const; template - void FEValuesBase::get_function_laplacians - (const IndexSet&, std::vector&) const; + void FEValuesBase::get_function_laplacians + (const IndexSet&, std::vector&) const; template - void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, std::vector&) const; + void FEValuesBase::get_function_laplacians + (const IndexSet&, const VectorSlice >&, std::vector&) const; template - void FEValuesBase::get_function_laplacians - (const IndexSet&, std::vector > &) const; + void FEValuesBase::get_function_laplacians + (const IndexSet&, std::vector > &) const; template - void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_laplacians + (const IndexSet&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_laplacians - (const IndexSet&, const VectorSlice >&, - std::vector > &, bool) const; + void FEValuesBase::get_function_laplacians + (const IndexSet&, const VectorSlice >&, + std::vector > &, bool) const; template - void FEValuesBase::get_function_third_derivatives - (const IndexSet&, std::vector > &) const; + void FEValuesBase::get_function_third_derivatives + (const IndexSet&, std::vector > &) const; template - void FEValuesBase::get_function_third_derivatives - (const IndexSet&, const VectorSlice >&, - std::vector > &) const; + void FEValuesBase::get_function_third_derivatives + (const IndexSet&, const VectorSlice >&, + std::vector > &) const; template - void FEValuesBase::get_function_third_derivatives - (const IndexSet&, std::vector > > &, bool) const; + void FEValuesBase::get_function_third_derivatives + (const IndexSet&, std::vector > > &, bool) const; template - void FEValuesBase::get_function_third_derivatives - (const IndexSet&, const VectorSlice >&, - VectorSlice > > >, bool) const; + void FEValuesBase::get_function_third_derivatives + (const IndexSet&, const VectorSlice >&, + VectorSlice > > >, bool) const; #endif - } +} diff --git a/source/fe/mapping.inst.in b/source/fe/mapping.inst.in index adee71b423..e2cf2b8ef8 100644 --- a/source/fe/mapping.inst.in +++ b/source/fe/mapping.inst.in @@ -17,9 +17,9 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class Mapping; #endif - } +} diff --git a/source/fe/mapping_c1.inst.in b/source/fe/mapping_c1.inst.in index 0760badab0..3c5b80d4ec 100644 --- a/source/fe/mapping_c1.inst.in +++ b/source/fe/mapping_c1.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class MappingC1; - } +} diff --git a/source/fe/mapping_cartesian.inst.in b/source/fe/mapping_cartesian.inst.in index c7c042ed33..9d657cff7f 100644 --- a/source/fe/mapping_cartesian.inst.in +++ b/source/fe/mapping_cartesian.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class MappingCartesian; - } +} diff --git a/source/fe/mapping_fe_field.inst.in b/source/fe/mapping_fe_field.inst.in index 50ffbefef0..7041afe7fa 100644 --- a/source/fe/mapping_fe_field.inst.in +++ b/source/fe/mapping_fe_field.inst.in @@ -17,10 +17,10 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; VEC : REAL_SERIAL_VECTORS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class MappingFEField >; #endif - } +} diff --git a/source/fe/mapping_manifold.inst.in b/source/fe/mapping_manifold.inst.in index c4f314d5e9..75bfc988af 100644 --- a/source/fe/mapping_manifold.inst.in +++ b/source/fe/mapping_manifold.inst.in @@ -15,9 +15,9 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class MappingManifold; #endif - } +} diff --git a/source/fe/mapping_q.inst.in b/source/fe/mapping_q.inst.in index eda826c6c1..771708e1ec 100644 --- a/source/fe/mapping_q.inst.in +++ b/source/fe/mapping_q.inst.in @@ -17,9 +17,9 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class MappingQ; #endif - } +} diff --git a/source/fe/mapping_q1.inst.in b/source/fe/mapping_q1.inst.in index fc5ab8b344..f2100e2a49 100644 --- a/source/fe/mapping_q1.inst.in +++ b/source/fe/mapping_q1.inst.in @@ -15,10 +15,10 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class MappingQ1; template struct StaticMappingQ1; #endif - } +} diff --git a/source/fe/mapping_q1_eulerian.inst.in b/source/fe/mapping_q1_eulerian.inst.in index f07fa43b80..3e171a640b 100644 --- a/source/fe/mapping_q1_eulerian.inst.in +++ b/source/fe/mapping_q1_eulerian.inst.in @@ -15,10 +15,10 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; VEC : REAL_SERIAL_VECTORS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class MappingQ1Eulerian; #endif - } +} diff --git a/source/fe/mapping_q_eulerian.inst.in b/source/fe/mapping_q_eulerian.inst.in index 9b52c89095..c7971c67f9 100644 --- a/source/fe/mapping_q_eulerian.inst.in +++ b/source/fe/mapping_q_eulerian.inst.in @@ -15,10 +15,10 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; VEC : REAL_SERIAL_VECTORS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class MappingQEulerian; #endif - } +} diff --git a/source/fe/mapping_q_generic.inst.in b/source/fe/mapping_q_generic.inst.in index 06156a2cce..1eb9552b89 100644 --- a/source/fe/mapping_q_generic.inst.in +++ b/source/fe/mapping_q_generic.inst.in @@ -15,9 +15,9 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class MappingQGeneric; #endif - } +} diff --git a/source/grid/grid_generator.inst.in b/source/grid/grid_generator.inst.in index 77b852f4c8..3d60241d21 100644 --- a/source/grid/grid_generator.inst.in +++ b/source/grid/grid_generator.inst.in @@ -15,27 +15,27 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -namespace GridGenerator -\{ +{ + namespace GridGenerator + \{ #if deal_II_dimension <= deal_II_space_dimension template void - hyper_rectangle ( - Triangulation &, - const Point&, const Point&, - const bool); - + hyper_rectangle ( + Triangulation &, + const Point&, const Point&, + const bool); + template void - hyper_cube ( - Triangulation &, const double, const double, const bool); - + hyper_cube ( + Triangulation &, const double, const double, const bool); + template void - subdivided_hyper_cube ( - Triangulation &, - const unsigned int, const double, const double); + subdivided_hyper_cube ( + Triangulation &, + const unsigned int, const double, const double); - template void + template void subdivided_hyper_rectangle (Triangulation &, const std::vector&, @@ -43,133 +43,133 @@ namespace GridGenerator const Point&, const bool); - template void - subdivided_parallelepiped - (Triangulation &, - const Point &, - const std_cxx11::array,deal_II_dimension> &, - const std::vector &, - const bool colorize); + template void + subdivided_parallelepiped + (Triangulation &, + const Point &, + const std_cxx11::array,deal_II_dimension> &, + const std::vector &, + const bool colorize); - template void + template void hyper_cross (Triangulation &, const std::vector &, const bool); - - template void + + template void cheese (Triangulation &, const std::vector &); - + template - void - merge_triangulations - (const Triangulation &triangulation_1, - const Triangulation &triangulation_2, - Triangulation &result); - + void + merge_triangulations + (const Triangulation &triangulation_1, + const Triangulation &triangulation_2, + Triangulation &result); + template - void - create_union_triangulation - (const Triangulation &triangulation_1, - const Triangulation &triangulation_2, - Triangulation &result); + void + create_union_triangulation + (const Triangulation &triangulation_1, + const Triangulation &triangulation_2, + Triangulation &result); template - void - create_triangulation_with_removed_cells (const Triangulation &input_triangulation, - const std::set::active_cell_iterator> &cells_to_remove, - Triangulation &result); - + void + create_triangulation_with_removed_cells (const Triangulation &input_triangulation, + const std::set::active_cell_iterator> &cells_to_remove, + Triangulation &result); + #endif -\} - } + \} +} for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; Container : TRIANGULATION_AND_DOFHANDLER_TEMPLATES) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace GridGenerator \{ #if deal_II_dimension != 1 - template + template #ifndef _MSC_VER - std::map::cell_iterator, - Container::face_iterator> + std::map::cell_iterator, + Container::face_iterator> #else - ExtractBoundaryMesh::return_type + ExtractBoundaryMesh::return_type #endif - extract_boundary_mesh (const Container &mesh, - Container &boundary_mesh, - const std::set &boundary_ids); + extract_boundary_mesh (const Container &mesh, + Container &boundary_mesh, + const std::set &boundary_ids); #endif - \} + \} #endif - } +} for (deal_II_dimension : DIMENSIONS) { -namespace GridGenerator \{ - - template + namespace GridGenerator \{ + + template void subdivided_hyper_rectangle( - Triangulation &, - const std::vector > &, - const Point &, - const Point &, - const bool ); - + Triangulation &, + const std::vector > &, + const Point &, + const Point &, + const bool ); + template void - simplex ( - Triangulation &, - const std::vector >&); - + simplex ( + Triangulation &, + const std::vector >&); + template void - parallelepiped ( - Triangulation&, - const Point (&) [deal_II_dimension], - const bool); - + parallelepiped ( + Triangulation&, + const Point (&) [deal_II_dimension], + const bool); + template void - subdivided_parallelepiped ( - Triangulation&, - const unsigned int, - const Point (&) [deal_II_dimension], - const bool); + subdivided_parallelepiped ( + Triangulation&, + const unsigned int, + const Point (&) [deal_II_dimension], + const bool); - #ifndef _MSC_VER +#ifndef _MSC_VER template void - subdivided_parallelepiped ( - Triangulation&, - const unsigned int (&) [deal_II_dimension], - const Point (&) [deal_II_dimension], - const bool); - #else - template void - subdivided_parallelepiped ( - Triangulation&, - const unsigned int*, - const Point (&) [deal_II_dimension], - const bool); - #endif - - -\} - } + subdivided_parallelepiped ( + Triangulation&, + const unsigned int (&) [deal_II_dimension], + const Point (&) [deal_II_dimension], + const bool); +#else + template void + subdivided_parallelepiped ( + Triangulation&, + const unsigned int*, + const Point (&) [deal_II_dimension], + const bool); +#endif + + + \} +} for (deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS; deal_II_space_dimension_2 : SPACE_DIMENSIONS) { -namespace GridGenerator \{ + namespace GridGenerator \{ #if (deal_II_dimension <= deal_II_space_dimension) && (deal_II_dimension <= deal_II_space_dimension_2) - template - void - flatten_triangulation<>(const Triangulation &, - Triangulation&); + template + void + flatten_triangulation<>(const Triangulation &, + Triangulation&); #endif -\} + \} } diff --git a/source/grid/grid_in.inst.in b/source/grid/grid_in.inst.in index 4a17b02061..7f70665a28 100644 --- a/source/grid/grid_in.inst.in +++ b/source/grid/grid_in.inst.in @@ -15,9 +15,9 @@ for (deal_II_dimension, deal_II_space_dimension : DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class GridIn; #endif - } +} diff --git a/source/grid/grid_out.inst.in b/source/grid/grid_out.inst.in index c36139e9d2..ff70778de0 100644 --- a/source/grid/grid_out.inst.in +++ b/source/grid/grid_out.inst.in @@ -16,93 +16,93 @@ for (deal_II_dimension : DIMENSIONS) - { +{ #if deal_II_dimension > 1 template void GridOut::write_dx - (const Triangulation&, - std::ostream&) const; + (const Triangulation&, + std::ostream&) const; template void GridOut::write_mathgl - (const Triangulation&, - std::ostream&) const; + (const Triangulation&, + std::ostream&) const; #endif template void GridOut::write_msh - (const Triangulation&, - std::ostream&) const; + (const Triangulation&, + std::ostream&) const; #if deal_II_dimension != 2 template void GridOut::write_xfig - (const Triangulation&, - std::ostream&, - const Mapping*) const; + (const Triangulation&, + std::ostream&, + const Mapping*) const; #endif template void GridOut::write_gnuplot - (const Triangulation&, - std::ostream&, - const Mapping*) const; + (const Triangulation&, + std::ostream&, + const Mapping*) const; template void GridOut::write_ucd - (const Triangulation &, - std::ostream &) const; + (const Triangulation &, + std::ostream &) const; template void GridOut::write_eps - (const Triangulation &, - std::ostream &, - const Mapping *) const; + (const Triangulation &, + std::ostream &, + const Mapping *) const; template void GridOut::write_vtk - (const Triangulation&, - std::ostream&) const; + (const Triangulation&, + std::ostream&) const; template void GridOut::write_vtu - (const Triangulation&, - std::ostream&) const; + (const Triangulation&, + std::ostream&) const; template void GridOut::write_mesh_per_processor_as_vtu - (const Triangulation&, - const std::string&, - const bool, - const bool) const; + (const Triangulation&, + const std::string&, + const bool, + const bool) const; template void GridOut::write - (const Triangulation &, - std::ostream &, const OutputFormat, - const Mapping *) const; + (const Triangulation &, + std::ostream &, const OutputFormat, + const Mapping *) const; template void GridOut::write - (const Triangulation &, - std::ostream &, const Mapping *) const; + (const Triangulation &, + std::ostream &, const Mapping *) const; } for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension < deal_II_space_dimension template void GridOut::write_msh - (const Triangulation&, - std::ostream&) const; + (const Triangulation&, + std::ostream&) const; template void GridOut::write_ucd - (const Triangulation &, - std::ostream &) const; - template void GridOut::write_gnuplot - (const Triangulation&, - std::ostream&, - const Mapping*) const; - template void GridOut::write_vtk - (const Triangulation&, - std::ostream&) const; - template void GridOut::write_vtu - (const Triangulation&, - std::ostream&) const; - template void GridOut::write_mesh_per_processor_as_vtu - (const Triangulation&, - const std::string&, - const bool, - const bool) const; + (const Triangulation &, + std::ostream &) const; + template void GridOut::write_gnuplot + (const Triangulation&, + std::ostream&, + const Mapping*) const; + template void GridOut::write_vtk + (const Triangulation&, + std::ostream&) const; + template void GridOut::write_vtu + (const Triangulation&, + std::ostream&) const; + template void GridOut::write_mesh_per_processor_as_vtu + (const Triangulation&, + const std::string&, + const bool, + const bool) const; template void GridOut::write - (const Triangulation &, - std::ostream &, const OutputFormat, - const Mapping *) const; + (const Triangulation &, + std::ostream &, const OutputFormat, + const Mapping *) const; template void GridOut::write - (const Triangulation &, - std::ostream &, const Mapping *) const; + (const Triangulation &, + std::ostream &, const Mapping *) const; #endif - } +} diff --git a/source/grid/grid_refinement.inst.in b/source/grid/grid_refinement.inst.in index c442c293e8..7ec7d70e19 100644 --- a/source/grid/grid_refinement.inst.in +++ b/source/grid/grid_refinement.inst.in @@ -18,108 +18,108 @@ for (S : REAL_SCALARS; deal_II_dimension : DIMENSIONS) { - template - void - GridRefinement:: - refine,deal_II_dimension> - (Triangulation &, - const dealii::Vector &, - const double, - const unsigned int); + template + void + GridRefinement:: + refine,deal_II_dimension> + (Triangulation &, + const dealii::Vector &, + const double, + const unsigned int); - template - void - GridRefinement:: - coarsen,deal_II_dimension> - (Triangulation &, - const dealii::Vector &, - const double); + template + void + GridRefinement:: + coarsen,deal_II_dimension> + (Triangulation &, + const dealii::Vector &, + const double); - template - void - GridRefinement:: - refine_and_coarsen_fixed_number,deal_II_dimension> - (Triangulation &, - const dealii::Vector &, - const double, - const double, - const unsigned int); + template + void + GridRefinement:: + refine_and_coarsen_fixed_number,deal_II_dimension> + (Triangulation &, + const dealii::Vector &, + const double, + const double, + const unsigned int); - template - void - GridRefinement:: - refine_and_coarsen_fixed_fraction,deal_II_dimension> - (Triangulation &, - const dealii::Vector &, - const double, - const double, - const unsigned int); + template + void + GridRefinement:: + refine_and_coarsen_fixed_fraction,deal_II_dimension> + (Triangulation &, + const dealii::Vector &, + const double, + const double, + const unsigned int); - template - void - GridRefinement:: - refine_and_coarsen_optimize,deal_II_dimension> - (Triangulation &, - const dealii::Vector &, - const unsigned int); + template + void + GridRefinement:: + refine_and_coarsen_optimize,deal_II_dimension> + (Triangulation &, + const dealii::Vector &, + const unsigned int); #if deal_II_dimension < 3 - template - void - GridRefinement:: - refine,deal_II_dimension+1> - (Triangulation &, - const dealii::Vector &, - const double, - const unsigned int); + template + void + GridRefinement:: + refine,deal_II_dimension+1> + (Triangulation &, + const dealii::Vector &, + const double, + const unsigned int); - template - void - GridRefinement:: - coarsen,deal_II_dimension+1> - (Triangulation &, - const dealii::Vector &, - const double); + template + void + GridRefinement:: + coarsen,deal_II_dimension+1> + (Triangulation &, + const dealii::Vector &, + const double); - template - void - GridRefinement:: - refine_and_coarsen_fixed_number,deal_II_dimension+1> - (Triangulation &, - const dealii::Vector &, - const double, - const double, - const unsigned int); + template + void + GridRefinement:: + refine_and_coarsen_fixed_number,deal_II_dimension+1> + (Triangulation &, + const dealii::Vector &, + const double, + const double, + const unsigned int); - template - void - GridRefinement:: - refine_and_coarsen_fixed_fraction,deal_II_dimension+1> - (Triangulation &, - const dealii::Vector &, - const double, - const double, - const unsigned int); + template + void + GridRefinement:: + refine_and_coarsen_fixed_fraction,deal_II_dimension+1> + (Triangulation &, + const dealii::Vector &, + const double, + const double, + const unsigned int); - template - void - GridRefinement:: - refine_and_coarsen_optimize,deal_II_dimension+1> - (Triangulation &, - const dealii::Vector &, - const unsigned int); + template + void + GridRefinement:: + refine_and_coarsen_optimize,deal_II_dimension+1> + (Triangulation &, + const dealii::Vector &, + const unsigned int); #endif } for (deal_II_dimension : DIMENSIONS) { - template - std::pair - GridRefinement:: - adjust_refine_and_coarsen_number_fraction - (const unsigned int, - const unsigned int, - const double, - const double); + template + std::pair + GridRefinement:: + adjust_refine_and_coarsen_number_fraction + (const unsigned int, + const unsigned int, + const double, + const double); } diff --git a/source/grid/grid_tools.inst.in b/source/grid/grid_tools.inst.in index df41e6c197..c01c63d55f 100644 --- a/source/grid/grid_tools.inst.in +++ b/source/grid/grid_tools.inst.in @@ -19,50 +19,50 @@ for (X : TRIANGULATION_AND_DOFHANDLERS; deal_II_dimension : DIMENSIONS ; deal_II { #if deal_II_dimension <= deal_II_space_dimension - namespace GridTools \{ + namespace GridTools \{ - template + template unsigned int find_closest_vertex (const X &, const Point &); - template + template std::vector::type> find_cells_adjacent_to_vertex(const X &, const unsigned int); - template + template dealii::internal::ActiveCellIterator::type find_active_cell_around_point (const X &, const Point &p); - template + template std::pair::type, Point > find_active_cell_around_point (const Mapping &, const X &, const Point &); - template + template std::vector::type> compute_active_cell_halo_layer (const X &, const std_cxx11::function::type&)> &); - template + template std::vector::type> compute_ghost_cell_halo_layer (const X &); - template + template std::list > get_finest_common_cells (const X &mesh_1, const X &mesh_2); - template + template bool have_same_coarse_mesh (const X &mesh_1, const X &mesh_2); - \} + \} - #endif +#endif } // now also instantiate a few additional functions for parallel::distributed::Triangulation @@ -70,14 +70,14 @@ for (deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS { #if deal_II_dimension <= deal_II_space_dimension - namespace GridTools \{ + namespace GridTools \{ - template - std::map - compute_local_to_global_vertex_index_map(const parallel::distributed::Triangulation &triangulation); - \} + template + std::map + compute_local_to_global_vertex_index_map(const parallel::distributed::Triangulation &triangulation); + \} - #endif +#endif } @@ -98,106 +98,106 @@ for (deal_II_space_dimension : SPACE_DIMENSIONS) for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace GridTools \{ template - double - diameter - (const Triangulation &); + double + diameter + (const Triangulation &); template - double - volume - (const Triangulation &, - const Mapping &); + double + volume + (const Triangulation &, + const Mapping &); template - void delete_unused_vertices (std::vector > &, - std::vector > &, - SubCellData &); + void delete_unused_vertices (std::vector > &, + std::vector > &, + SubCellData &); template - void delete_duplicated_vertices (std::vector > &, - std::vector > &, - SubCellData &, - std::vector &, - double); + void delete_duplicated_vertices (std::vector > &, + std::vector > &, + SubCellData &, + std::vector &, + double); template - void shift (const Tensor<1,deal_II_space_dimension> &, - Triangulation &); + void shift (const Tensor<1,deal_II_space_dimension> &, + Triangulation &); template - void scale (const double, - Triangulation &); + void scale (const double, + Triangulation &); #if deal_II_space_dimension==3 template - void - rotate (const double, - const unsigned int , - Triangulation &); + void + rotate (const double, + const unsigned int , + Triangulation &); #endif template - void distort_random (const double, - Triangulation &, - const bool); + void distort_random (const double, + Triangulation &, + const bool); template - void get_face_connectivity_of_cells - (const Triangulation &triangulation, - DynamicSparsityPattern &cell_connectivity); + void get_face_connectivity_of_cells + (const Triangulation &triangulation, + DynamicSparsityPattern &cell_connectivity); template - void get_face_connectivity_of_cells - (const Triangulation &triangulation, - SparsityPattern &cell_connectivity); + void get_face_connectivity_of_cells + (const Triangulation &triangulation, + SparsityPattern &cell_connectivity); template - void get_vertex_connectivity_of_cells - (const Triangulation &triangulation, - DynamicSparsityPattern &cell_connectivity); + void get_vertex_connectivity_of_cells + (const Triangulation &triangulation, + DynamicSparsityPattern &cell_connectivity); template - void partition_triangulation (const unsigned int, - Triangulation &); + void partition_triangulation (const unsigned int, + Triangulation &); template - void partition_triangulation (const unsigned int, - const SparsityPattern &, - Triangulation &); + void partition_triangulation (const unsigned int, + const SparsityPattern &, + Triangulation &); template - std::pair::active_cell_iterator, - Point > - find_active_cell_around_point - (const hp::MappingCollection &, - const hp::DoFHandler &, - const Point &); + std::pair::active_cell_iterator, + Point > + find_active_cell_around_point + (const hp::MappingCollection &, + const hp::DoFHandler &, + const Point &); template - void get_subdomain_association (const Triangulation &, - std::vector &); + void get_subdomain_association (const Triangulation &, + std::vector &); template unsigned int count_cells_with_subdomain_association( - const Triangulation &, - const types::subdomain_id); + const Triangulation &, + const types::subdomain_id); template std::vector get_locally_owned_vertices (const Triangulation &); template - double - minimal_cell_diameter (const Triangulation &triangulation); + double + minimal_cell_diameter (const Triangulation &triangulation); template - double - maximal_cell_diameter (const Triangulation &triangulation); + double + maximal_cell_diameter (const Triangulation &triangulation); template std::map > @@ -218,10 +218,10 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS # endif template - Triangulation::DistortedCellList - fix_up_distorted_child_cells - (const Triangulation::DistortedCellList &distorted_cells, - Triangulation &triangulation); + Triangulation::DistortedCellList + fix_up_distorted_child_cells + (const Triangulation::DistortedCellList &distorted_cells, + Triangulation &triangulation); #endif @@ -230,48 +230,48 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS - } +} for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; Container : DOFHANDLER_TEMPLATES) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace GridTools \{ - template - std::map< types::global_dof_index,std::vector::active_cell_iterator> > - get_dof_to_support_patch_map > - (Container &dof_handler); + template + std::map< types::global_dof_index,std::vector::active_cell_iterator> > + get_dof_to_support_patch_map > + (Container &dof_handler); \} #endif - } +} for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; Container : TRIANGULATION_AND_DOFHANDLER_TEMPLATES) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace GridTools \{ - template - std::vector::active_cell_iterator> - get_patch_around_cell > - (const Container::active_cell_iterator &cell); + template + std::vector::active_cell_iterator> + get_patch_around_cell > + (const Container::active_cell_iterator &cell); - template - std::vector< Container::cell_iterator> - get_cells_at_coarsest_common_level > ( - const std::vector< Container::active_cell_iterator> & patch_cells); + template + std::vector< Container::cell_iterator> + get_cells_at_coarsest_common_level > ( + const std::vector< Container::active_cell_iterator> & patch_cells); - template - void build_triangulation_from_patch > ( - const std::vector::active_cell_iterator> &patch, - Triangulation::dimension,Container::space_dimension> &local_triangulation, - std::map::active_cell_iterator, - Container::active_cell_iterator > &patch_to_global_tria_map); + template + void build_triangulation_from_patch > ( + const std::vector::active_cell_iterator> &patch, + Triangulation::dimension,Container::space_dimension> &local_triangulation, + std::map::active_cell_iterator, + Container::active_cell_iterator > &patch_to_global_tria_map); \} #endif - } +} // instantiate the following functions only for the "sequential" containers. this @@ -283,37 +283,37 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS for (X : SEQUENTIAL_TRIANGULATION_AND_DOFHANDLERS; deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS) { #if deal_II_dimension <= deal_II_space_dimension - namespace GridTools \{ + namespace GridTools \{ template bool orthogonal_equality (std::bitset<3> &, - const X::active_face_iterator&, - const X::active_face_iterator&, - const int, - const Tensor<1,deal_II_space_dimension> &, - const FullMatrix &); + const X::active_face_iterator&, + const X::active_face_iterator&, + const int, + const Tensor<1,deal_II_space_dimension> &, + const FullMatrix &); template bool orthogonal_equality (std::bitset<3> &, - const X::face_iterator&, - const X::face_iterator&, - const int, - const Tensor<1,deal_II_space_dimension> &, - const FullMatrix &); + const X::face_iterator&, + const X::face_iterator&, + const int, + const Tensor<1,deal_II_space_dimension> &, + const FullMatrix &); template bool orthogonal_equality (const X::active_face_iterator&, - const X::active_face_iterator&, - const int, - const Tensor<1,deal_II_space_dimension> &, - const FullMatrix &); + const X::active_face_iterator&, + const int, + const Tensor<1,deal_II_space_dimension> &, + const FullMatrix &); template bool orthogonal_equality (const X::face_iterator&, - const X::face_iterator&, - const int, - const Tensor<1,deal_II_space_dimension> &, - const FullMatrix &); + const X::face_iterator&, + const int, + const Tensor<1,deal_II_space_dimension> &, + const FullMatrix &); template void collect_periodic_faces (const X &, @@ -332,92 +332,92 @@ for (X : SEQUENTIAL_TRIANGULATION_AND_DOFHANDLERS; deal_II_dimension : DIMENSION const Tensor<1,X::space_dimension> &, const FullMatrix &); - \} + \} #endif } for (deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS) { #if deal_II_dimension <= deal_II_space_dimension - #if deal_II_dimension >= 2 - - namespace GridTools \{ - template - void - collect_periodic_faces > - (const parallel::distributed::Triangulation &, - const types::boundary_id, - const types::boundary_id, - const int, - std::vector::cell_iterator> > &, - const Tensor<1,parallel::distributed::Triangulation::space_dimension> &, - const FullMatrix &); - - template - void - collect_periodic_faces > - (const parallel::distributed::Triangulation &, - const types::boundary_id, - const int, - std::vector::cell_iterator> > &, - const Tensor<1,parallel::distributed::Triangulation::space_dimension> &, - const FullMatrix &); - \} - #endif +#if deal_II_dimension >= 2 + + namespace GridTools \{ + template + void + collect_periodic_faces > + (const parallel::distributed::Triangulation &, + const types::boundary_id, + const types::boundary_id, + const int, + std::vector::cell_iterator> > &, + const Tensor<1,parallel::distributed::Triangulation::space_dimension> &, + const FullMatrix &); + + template + void + collect_periodic_faces > + (const parallel::distributed::Triangulation &, + const types::boundary_id, + const int, + std::vector::cell_iterator> > &, + const Tensor<1,parallel::distributed::Triangulation::space_dimension> &, + const FullMatrix &); + \} +#endif #endif } for (deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS) { #if deal_II_space_dimension >= deal_II_dimension - namespace GridTools \{ - template void copy_boundary_to_manifold_id - (Triangulation &, const bool); - template void copy_material_to_manifold_id - (Triangulation &, const bool); + namespace GridTools \{ + template void copy_boundary_to_manifold_id + (Triangulation &, const bool); + template void copy_material_to_manifold_id + (Triangulation &, const bool); -\} + \} #endif } for (deal_II_dimension : DIMENSIONS) { - template - std::pair - GridTools:: - get_longest_direction - (Triangulation::active_cell_iterator); - - template - void - GridTools:: - remove_hanging_nodes - (Triangulation &tria, bool, unsigned int); - - template - void - GridTools:: - remove_anisotropy - (Triangulation &, double, unsigned int); + template + std::pair + GridTools:: + get_longest_direction + (Triangulation::active_cell_iterator); + + template + void + GridTools:: + remove_hanging_nodes + (Triangulation &tria, bool, unsigned int); + + template + void + GridTools:: + remove_anisotropy + (Triangulation &, double, unsigned int); #if deal_II_dimension < 3 - template - std::pair - GridTools:: - get_longest_direction - (Triangulation::active_cell_iterator); - - template - void - GridTools:: - remove_hanging_nodes - (Triangulation &tria, bool, unsigned int); - - template - void - GridTools:: - remove_anisotropy - (Triangulation &, double, unsigned int); + template + std::pair + GridTools:: + get_longest_direction + (Triangulation::active_cell_iterator); + + template + void + GridTools:: + remove_hanging_nodes + (Triangulation &tria, bool, unsigned int); + + template + void + GridTools:: + remove_anisotropy + (Triangulation &, double, unsigned int); #endif } diff --git a/source/grid/intergrid_map.inst.in b/source/grid/intergrid_map.inst.in index 7cda634587..69a448571a 100644 --- a/source/grid/intergrid_map.inst.in +++ b/source/grid/intergrid_map.inst.in @@ -16,8 +16,8 @@ for (X : TRIANGULATION_AND_DOFHANDLERS; deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class InterGridMap; #endif - } +} diff --git a/source/grid/manifold.inst.in b/source/grid/manifold.inst.in index 1a7962e780..3cd1d67db9 100644 --- a/source/grid/manifold.inst.in +++ b/source/grid/manifold.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class Manifold; template class FlatManifold; @@ -25,7 +25,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS template class ChartManifold; template class ChartManifold; #endif - } +} diff --git a/source/grid/manifold_lib.inst.in b/source/grid/manifold_lib.inst.in index d47a6343d0..876da5d0ff 100644 --- a/source/grid/manifold_lib.inst.in +++ b/source/grid/manifold_lib.inst.in @@ -15,17 +15,17 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class PolarManifold; template class SphericalManifold; template class CylindricalManifold; - template class FunctionManifold; + template class FunctionManifold; template class FunctionManifold; template class FunctionManifold; #endif #if deal_II_dimension == deal_II_space_dimension - template class TorusManifold; + template class TorusManifold; #endif - } +} diff --git a/source/grid/tria.inst.in b/source/grid/tria.inst.in index 817fb1de4a..42008acb0b 100644 --- a/source/grid/tria.inst.in +++ b/source/grid/tria.inst.in @@ -16,11 +16,11 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template class Triangulation; #endif #if deal_II_dimension == deal_II_space_dimension template struct CellData; #endif - } +} diff --git a/source/grid/tria_accessor.inst.in b/source/grid/tria_accessor.inst.in index e3ed445f87..676fb344d7 100644 --- a/source/grid/tria_accessor.inst.in +++ b/source/grid/tria_accessor.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class TriaAccessorBase<1,deal_II_dimension>; #if deal_II_dimension >= 2 template class TriaAccessorBase<2,deal_II_dimension>; @@ -90,4 +90,4 @@ for (deal_II_dimension : DIMENSIONS) #endif #endif - } +} diff --git a/source/grid/tria_boundary.inst.in b/source/grid/tria_boundary.inst.in index 1472e484ef..86e7c616e8 100644 --- a/source/grid/tria_boundary.inst.in +++ b/source/grid/tria_boundary.inst.in @@ -16,12 +16,12 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { -#if deal_II_dimension <= deal_II_space_dimension +{ +#if deal_II_dimension <= deal_II_space_dimension template class Boundary; template class StraightBoundary; #endif - } +} diff --git a/source/grid/tria_boundary_lib.inst.in b/source/grid/tria_boundary_lib.inst.in index 695170153f..eb7ef8f762 100644 --- a/source/grid/tria_boundary_lib.inst.in +++ b/source/grid/tria_boundary_lib.inst.in @@ -15,7 +15,7 @@ for (deal_II_dimension : DIMENSIONS) - { +{ template class CylinderBoundary; template class ConeBoundary; template class HyperBallBoundary; @@ -27,8 +27,8 @@ for (deal_II_dimension : DIMENSIONS) template class HyperBallBoundary; #endif #if deal_II_dimension == 3 - template class CylinderBoundary; + template class CylinderBoundary; #endif - } +} diff --git a/source/grid/tria_objects.inst.in b/source/grid/tria_objects.inst.in index 7df5d1fecc..cd5a8bafc1 100644 --- a/source/grid/tria_objects.inst.in +++ b/source/grid/tria_objects.inst.in @@ -15,9 +15,9 @@ for (deal_II_dimension : DIMENSIONS) - { +{ #if deal_II_dimension >= 3 template dealii::Triangulation::raw_hex_iterator TriaObjects >::next_free_hex(const dealii::Triangulation &, const unsigned int); #endif - } +} diff --git a/source/hp/dof_handler.inst.in b/source/hp/dof_handler.inst.in index 35bff5a06c..eac399e75d 100644 --- a/source/hp/dof_handler.inst.in +++ b/source/hp/dof_handler.inst.in @@ -14,108 +14,108 @@ // --------------------------------------------------------------------- for (scalar: REAL_SCALARS; deal_II_dimension : DIMENSIONS) - { +{ namespace hp \{ - template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; - + template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; + #if deal_II_dimension < 3 - template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; + template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; #endif #if deal_II_dimension == 1 - template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; + template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; #endif \} - } - +} + for (scalar: COMPLEX_SCALARS; deal_II_dimension : DIMENSIONS) - { +{ namespace hp \{ - template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; - + template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; + #if deal_II_dimension < 3 - template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; + template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; #endif - + #if deal_II_dimension == 1 - template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; + template types::global_dof_index DoFHandler::n_boundary_dofs (const std::map*> &boundary_ids) const; #endif \} - } +} for (deal_II_dimension : DIMENSIONS) { - namespace hp - \{ + namespace hp + \{ template class DoFHandler; #if deal_II_dimension != 3 template class DoFHandler; - + template types::global_dof_index DoFHandler::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; - + template void DoFHandler::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; - - #if deal_II_dimension >= 2 + +#if deal_II_dimension >= 2 template types::global_dof_index DoFHandler::get_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; - + template void DoFHandler::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; - #endif +#endif #endif #if deal_II_dimension == 3 - template class DoFHandler<1, 3>; + template class DoFHandler<1, 3>; -template -types::global_dof_index -DoFHandler<1,3>::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; + template + types::global_dof_index + DoFHandler<1,3>::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; -template -void -DoFHandler<1,3>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; + template + void + DoFHandler<1,3>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; #endif -template -types::global_dof_index -DoFHandler::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; + template + types::global_dof_index + DoFHandler::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; #if deal_II_dimension >= 2 -template -types::global_dof_index -DoFHandler::get_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; + template + types::global_dof_index + DoFHandler::get_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; #if deal_II_dimension >= 3 -template -types::global_dof_index -DoFHandler::get_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; + template + types::global_dof_index + DoFHandler::get_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const; #endif #endif -template -void -DoFHandler::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; + template + void + DoFHandler::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; #if deal_II_dimension >= 2 -template -void -DoFHandler::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; + template + void + DoFHandler::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; #if deal_II_dimension >= 3 -template -void -DoFHandler::set_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; + template + void + DoFHandler::set_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const; #endif #endif - \} + \} } diff --git a/source/hp/fe_collection.inst.in b/source/hp/fe_collection.inst.in index 4a5b383915..9184926f09 100644 --- a/source/hp/fe_collection.inst.in +++ b/source/hp/fe_collection.inst.in @@ -16,8 +16,8 @@ for (deal_II_dimension : DIMENSIONS) { - namespace hp - \{ + namespace hp + \{ template class FECollection; #if deal_II_dimension != 3 @@ -26,5 +26,5 @@ for (deal_II_dimension : DIMENSIONS) #if deal_II_dimension == 3 template class FECollection<1,3>; #endif - \} + \} } diff --git a/source/hp/fe_values.inst.in b/source/hp/fe_values.inst.in index 57c8a5aec7..eb1265508e 100644 --- a/source/hp/fe_values.inst.in +++ b/source/hp/fe_values.inst.in @@ -16,87 +16,87 @@ for (deal_II_dimension : DIMENSIONS) { -namespace internal -\{ - namespace hp - \{ + namespace internal + \{ + namespace hp + \{ template class FEValuesBase >; template class FEValuesBase >; template class FEValuesBase >; - \} -\} + \} + \} -namespace hp -\{ - template class FEValues; - template class FEFaceValues; - template class FESubfaceValues; -\} + namespace hp + \{ + template class FEValues; + template class FEFaceValues; + template class FESubfaceValues; + \} #if deal_II_dimension != 3 -namespace internal -\{ - namespace hp - \{ + namespace internal + \{ + namespace hp + \{ template class FEValuesBase >; template class FEValuesBase >; template class FEValuesBase >; - \} -\} + \} + \} -namespace hp -\{ - template class FEValues; - template class FEFaceValues; - template class FESubfaceValues; -\} + namespace hp + \{ + template class FEValues; + template class FEFaceValues; + template class FESubfaceValues; + \} #endif #if deal_II_dimension == 3 -namespace internal -\{ - namespace hp - \{ + namespace internal + \{ + namespace hp + \{ template class FEValuesBase<1,1, dealii::FEValues<1,3> >; template class FEValuesBase<1,1-1, dealii::FEFaceValues<1,3> >; template class FEValuesBase<1,1-1, dealii::FESubfaceValues<1,3> >; - \} -\} + \} + \} -namespace hp -\{ - template class FEValues<1, 3>; - template class FEFaceValues<1, 3>; - template class FESubfaceValues<1, 3>; -\} + namespace hp + \{ + template class FEValues<1, 3>; + template class FEFaceValues<1, 3>; + template class FESubfaceValues<1, 3>; + \} #endif } for (dof_handler : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; lda : BOOL) { -namespace hp -\{ + namespace hp + \{ #if deal_II_dimension <= deal_II_space_dimension template void FEValues::reinit( - TriaIterator, lda> >, unsigned int, unsigned int, unsigned int); + TriaIterator, lda> >, unsigned int, unsigned int, unsigned int); template void FEFaceValues::reinit( - TriaIterator, lda> >, unsigned int, unsigned int, unsigned int, unsigned int); + TriaIterator, lda> >, unsigned int, unsigned int, unsigned int, unsigned int); template void FESubfaceValues::reinit( - TriaIterator, lda> >, unsigned int, unsigned int, unsigned int, unsigned int, unsigned int); + TriaIterator, lda> >, unsigned int, unsigned int, unsigned int, unsigned int, unsigned int); #endif -\} + \} } diff --git a/source/hp/mapping_collection.inst.in b/source/hp/mapping_collection.inst.in index fba1a1ecef..5bddbf725c 100644 --- a/source/hp/mapping_collection.inst.in +++ b/source/hp/mapping_collection.inst.in @@ -16,8 +16,8 @@ for (deal_II_dimension : DIMENSIONS) { - namespace hp - \{ + namespace hp + \{ template class MappingCollection; template struct StaticMappingQ1; @@ -30,5 +30,5 @@ for (deal_II_dimension : DIMENSIONS) template class MappingCollection<1,3>; template struct StaticMappingQ1<1,3>; #endif - \} + \} } diff --git a/source/lac/block_sparse_matrix.inst.in b/source/lac/block_sparse_matrix.inst.in index 7f2cbc9e10..65ea23cdff 100644 --- a/source/lac/block_sparse_matrix.inst.in +++ b/source/lac/block_sparse_matrix.inst.in @@ -14,6 +14,6 @@ // --------------------------------------------------------------------- for (S : REAL_SCALARS) - { +{ template class BlockSparseMatrix; - } +} diff --git a/source/lac/block_vector.inst.in b/source/lac/block_vector.inst.in index 4e69f2d709..34261faa55 100644 --- a/source/lac/block_vector.inst.in +++ b/source/lac/block_vector.inst.in @@ -16,24 +16,24 @@ for (S : REAL_SCALARS) - { +{ template class BlockVector; - } +} for (S1, S2 : REAL_SCALARS) - { +{ template void BlockVector::reinit(const BlockVector&, - const bool); - } + const bool); +} for (S : COMPLEX_SCALARS) - { +{ template class BlockVector; - } +} for (S1, S2 : COMPLEX_SCALARS) - { +{ template void BlockVector::reinit(const BlockVector&, - const bool); - } + const bool); +} diff --git a/source/lac/chunk_sparse_matrix.inst.in b/source/lac/chunk_sparse_matrix.inst.in index b951fc07e4..95723149c2 100644 --- a/source/lac/chunk_sparse_matrix.inst.in +++ b/source/lac/chunk_sparse_matrix.inst.in @@ -18,107 +18,107 @@ // real instantiations for (S : REAL_SCALARS) - { +{ template class ChunkSparseMatrix; - } +} for (S1, S2 : REAL_SCALARS) - { +{ template ChunkSparseMatrix & - ChunkSparseMatrix::copy_from (const ChunkSparseMatrix &); + ChunkSparseMatrix::copy_from (const ChunkSparseMatrix &); - template - void ChunkSparseMatrix::copy_from (const FullMatrix &); + template + void ChunkSparseMatrix::copy_from (const FullMatrix &); template void ChunkSparseMatrix::add (const S1, - const ChunkSparseMatrix &); - } + const ChunkSparseMatrix &); +} for (S1, S2 : REAL_SCALARS) - { +{ template S2 - ChunkSparseMatrix:: - matrix_norm_square (const Vector &) const; + ChunkSparseMatrix:: + matrix_norm_square (const Vector &) const; template S2 - ChunkSparseMatrix:: - matrix_scalar_product (const Vector &, - const Vector &) const; + ChunkSparseMatrix:: + matrix_scalar_product (const Vector &, + const Vector &) const; template S2 ChunkSparseMatrix:: - residual (Vector &, - const Vector &, - const Vector &) const; + residual (Vector &, + const Vector &, + const Vector &) const; template void ChunkSparseMatrix:: - precondition_SSOR (Vector &, - const Vector &, - const S1) const; + precondition_SSOR (Vector &, + const Vector &, + const S1) const; template void ChunkSparseMatrix:: - precondition_SOR (Vector &, - const Vector &, - const S1) const; + precondition_SOR (Vector &, + const Vector &, + const S1) const; template void ChunkSparseMatrix:: - precondition_TSOR (Vector &, - const Vector &, - const S1) const; + precondition_TSOR (Vector &, + const Vector &, + const S1) const; template void ChunkSparseMatrix:: - precondition_Jacobi (Vector &, - const Vector &, - const S1) const; + precondition_Jacobi (Vector &, + const Vector &, + const S1) const; template void ChunkSparseMatrix:: - SOR (Vector &, - const S1) const; + SOR (Vector &, + const S1) const; template void ChunkSparseMatrix:: - TSOR (Vector &, - const S1) const; + TSOR (Vector &, + const S1) const; template void ChunkSparseMatrix:: - SSOR (Vector &, - const S1) const; + SSOR (Vector &, + const S1) const; template void ChunkSparseMatrix:: - PSOR (Vector &, - const std::vector&, - const std::vector&, - const S1) const; + PSOR (Vector &, + const std::vector&, + const std::vector&, + const S1) const; template void ChunkSparseMatrix:: - TPSOR (Vector &, - const std::vector&, - const std::vector&, - const S1) const; + TPSOR (Vector &, + const std::vector&, + const std::vector&, + const S1) const; template void ChunkSparseMatrix:: - SOR_step (Vector &, - const Vector &, - const S1) const; + SOR_step (Vector &, + const Vector &, + const S1) const; template void ChunkSparseMatrix:: - TSOR_step (Vector &, - const Vector &, - const S1) const; + TSOR_step (Vector &, + const Vector &, + const S1) const; template void ChunkSparseMatrix:: - SSOR_step (Vector &, - const Vector &, - const S1) const; - } + SSOR_step (Vector &, + const Vector &, + const S1) const; +} for (S1, S2, S3 : REAL_SCALARS; - V1, V2 : DEAL_II_VEC_TEMPLATES) - { + V1, V2 : DEAL_II_VEC_TEMPLATES) +{ template void ChunkSparseMatrix:: - vmult (V1 &, const V2 &) const; + vmult (V1 &, const V2 &) const; template void ChunkSparseMatrix:: - Tvmult (V1 &, const V2 &) const; + Tvmult (V1 &, const V2 &) const; template void ChunkSparseMatrix:: - vmult_add (V1 &, const V2 &) const; + vmult_add (V1 &, const V2 &) const; template void ChunkSparseMatrix:: - Tvmult_add (V1 &, const V2 &) const; - } + Tvmult_add (V1 &, const V2 &) const; +} @@ -136,7 +136,7 @@ for (S1, S2, S3 : REAL_SCALARS; // template ChunkSparseMatrix & // ChunkSparseMatrix::copy_from (const ChunkSparseMatrix &); -// template +// template // void ChunkSparseMatrix::copy_from (const FullMatrix &); // template void ChunkSparseMatrix::add (const S1, @@ -209,7 +209,7 @@ for (S1, S2, S3 : REAL_SCALARS; // const S1) const; // template void ChunkSparseMatrix:: // SSOR_step (Vector &, -// const Vector &, +// const Vector &, // const S1) const; // } diff --git a/source/lac/constraint_matrix.inst.in b/source/lac/constraint_matrix.inst.in index 3fd397a5dd..4776d349ac 100644 --- a/source/lac/constraint_matrix.inst.in +++ b/source/lac/constraint_matrix.inst.in @@ -14,72 +14,72 @@ // --------------------------------------------------------------------- for (S: REAL_SCALARS; T : DEAL_II_VEC_TEMPLATES) - { +{ template void ConstraintMatrix::condense >(const T &, T &) const; template void ConstraintMatrix::condense >(T &vec) const; template void ConstraintMatrix::distribute_local_to_global > ( - const Vector&, const std::vector &, T &, const FullMatrix&) const; + const Vector&, const std::vector &, T &, const FullMatrix&) const; template void ConstraintMatrix::distribute_local_to_global > ( - const Vector&, const std::vector &, const std::vector &, T &, const FullMatrix&, bool) const; + const Vector&, const std::vector &, const std::vector &, T &, const FullMatrix&, bool) const; template void ConstraintMatrix::set_zero >(T &) const; - } +} for (S: REAL_SCALARS; T : DEAL_II_VEC_TEMPLATES) - { +{ template void ConstraintMatrix::condense >(const LinearAlgebra::distributed::T &, LinearAlgebra::distributed::T &) const; template void ConstraintMatrix::condense >(LinearAlgebra::distributed::T &vec) const; template void ConstraintMatrix::distribute_local_to_global > ( - const Vector&, const std::vector &, LinearAlgebra::distributed::T &, const FullMatrix&) const; + const Vector&, const std::vector &, LinearAlgebra::distributed::T &, const FullMatrix&) const; template void ConstraintMatrix::distribute_local_to_global > ( - const Vector&, const std::vector &, const std::vector &, LinearAlgebra::distributed::T &, const FullMatrix&, bool) const; + const Vector&, const std::vector &, const std::vector &, LinearAlgebra::distributed::T &, const FullMatrix&, bool) const; template void ConstraintMatrix::set_zero >(LinearAlgebra::distributed::T &) const; - } +} for (V: EXTERNAL_SEQUENTIAL_VECTORS) - { +{ template void ConstraintMatrix::condense(const V&, V&) const; template void ConstraintMatrix::condense(V&vec) const; template void ConstraintMatrix::distribute_local_to_global ( - const Vector&, const std::vector &, V&, const FullMatrix&) const; + const Vector&, const std::vector &, V&, const FullMatrix&) const; template void ConstraintMatrix::distribute_local_to_global ( - const Vector&, const std::vector &, const std::vector &, V&, const FullMatrix&, bool) const; + const Vector&, const std::vector &, const std::vector &, V&, const FullMatrix&, bool) const; template void ConstraintMatrix::set_zero(V&) const; - } +} for (V: EXTERNAL_PARALLEL_VECTORS) - { +{ template void ConstraintMatrix::set_zero(V&) const; - } +} for (S : REAL_SCALARS) - { +{ template void ConstraintMatrix::condense(SparseMatrix&) const; template void ConstraintMatrix::condense(BlockSparseMatrix&) const; - } +} for (S1 : REAL_SCALARS; S2 : REAL_SCALARS) - { +{ template void ConstraintMatrix::condense >(SparseMatrix&, Vector&) const; template void ConstraintMatrix::condense >(BlockSparseMatrix&, BlockVector&) const; - } +} for (S1 : COMPLEX_SCALARS) - { +{ template void ConstraintMatrix::condense >(SparseMatrix&, Vector&) const; - } +} for (Vec : SERIAL_VECTORS) - { +{ template void ConstraintMatrix::distribute(Vec &) const; - } +} for (S: COMPLEX_SCALARS; T : DEAL_II_VEC_TEMPLATES) - { +{ template void ConstraintMatrix::distribute >(T &) const; - } +} diff --git a/source/lac/full_matrix.inst.in b/source/lac/full_matrix.inst.in index fee41fcfed..610082cd24 100644 --- a/source/lac/full_matrix.inst.in +++ b/source/lac/full_matrix.inst.in @@ -16,127 +16,127 @@ for (S : REAL_SCALARS) - { +{ template class FullMatrix; template void FullMatrix::print( - LogStream&, const unsigned int, const unsigned int) const; + LogStream&, const unsigned int, const unsigned int) const; template void FullMatrix::print( - std::ostream&, const unsigned int, const unsigned int) const; + std::ostream&, const unsigned int, const unsigned int) const; template void FullMatrix::copy_from<1>( - const Tensor<2,1>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type); + const Tensor<2,1>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type); template void FullMatrix::copy_from<2>( - const Tensor<2,2>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type); + const Tensor<2,2>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type); template void FullMatrix::copy_from<3>( - const Tensor<2,3>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type); + const Tensor<2,3>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type); template void FullMatrix::copy_to<1>( - Tensor<2,1>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const; + Tensor<2,1>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const; template void FullMatrix::copy_to<2>( - Tensor<2,2>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const; + Tensor<2,2>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const; template void FullMatrix::copy_to<3>( - Tensor<2,3>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const; - } + Tensor<2,3>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const; +} for (S1, S2 : REAL_SCALARS) - { +{ template - FullMatrix& FullMatrix::operator = (const LAPACKFullMatrix&); + FullMatrix& FullMatrix::operator = (const LAPACKFullMatrix&); template - void FullMatrix::fill ( - const FullMatrix&, size_type, size_type, size_type, size_type); + void FullMatrix::fill ( + const FullMatrix&, size_type, size_type, size_type, size_type); template - void FullMatrix::add (const S1, const FullMatrix&); + void FullMatrix::add (const S1, const FullMatrix&); template - void FullMatrix::add (const S1, const FullMatrix&, - const S1, const FullMatrix&); + void FullMatrix::add (const S1, const FullMatrix&, + const S1, const FullMatrix&); template - void FullMatrix::add (const S1, const FullMatrix&, - const S1, const FullMatrix&, - const S1, const FullMatrix&); + void FullMatrix::add (const S1, const FullMatrix&, + const S1, const FullMatrix&, + const S1, const FullMatrix&); template - void FullMatrix::add ( - const FullMatrix&, S1, size_type, size_type, size_type, size_type); + void FullMatrix::add ( + const FullMatrix&, S1, size_type, size_type, size_type, size_type); template - void FullMatrix::Tadd (const S1, const FullMatrix&); + void FullMatrix::Tadd (const S1, const FullMatrix&); template - void FullMatrix::Tadd ( - const FullMatrix&, S1, size_type, size_type, size_type, size_type); + void FullMatrix::Tadd ( + const FullMatrix&, S1, size_type, size_type, size_type, size_type); template - void FullMatrix::equ (const S1, const FullMatrix&); + void FullMatrix::equ (const S1, const FullMatrix&); template - void FullMatrix::equ (const S1, const FullMatrix&, - const S1, const FullMatrix&); + void FullMatrix::equ (const S1, const FullMatrix&, + const S1, const FullMatrix&); template - void FullMatrix::equ (const S1, const FullMatrix&, - const S1, const FullMatrix&, - const S1, const FullMatrix&); + void FullMatrix::equ (const S1, const FullMatrix&, + const S1, const FullMatrix&, + const S1, const FullMatrix&); template - void FullMatrix::mmult (FullMatrix&, const FullMatrix&, const bool) const; + void FullMatrix::mmult (FullMatrix&, const FullMatrix&, const bool) const; template - void FullMatrix::Tmmult (FullMatrix&, const FullMatrix&, const bool) const; + void FullMatrix::Tmmult (FullMatrix&, const FullMatrix&, const bool) const; template - void FullMatrix::mTmult (FullMatrix&, const FullMatrix&, const bool) const; + void FullMatrix::mTmult (FullMatrix&, const FullMatrix&, const bool) const; template - void FullMatrix::TmTmult (FullMatrix&, const FullMatrix&, const bool) const; + void FullMatrix::TmTmult (FullMatrix&, const FullMatrix&, const bool) const; template - void FullMatrix::invert (const FullMatrix&); - - template - void FullMatrix::left_invert (const FullMatrix &); - template - void FullMatrix::right_invert (const FullMatrix &); + void FullMatrix::invert (const FullMatrix&); template - void FullMatrix::fill_permutation ( - const FullMatrix&, - const std::vector&, - const std::vector&); + void FullMatrix::left_invert (const FullMatrix &); template - void FullMatrix::vmult( - Vector&, const Vector&, bool) const; + void FullMatrix::right_invert (const FullMatrix &); + + template + void FullMatrix::fill_permutation ( + const FullMatrix&, + const std::vector&, + const std::vector&); + template + void FullMatrix::vmult( + Vector&, const Vector&, bool) const; template - void FullMatrix::Tvmult( - Vector&, const Vector&, bool) const; + void FullMatrix::Tvmult( + Vector&, const Vector&, bool) const; template - S2 FullMatrix::matrix_norm_square ( - const Vector &) const; + S2 FullMatrix::matrix_norm_square ( + const Vector &) const; template - S2 FullMatrix::matrix_scalar_product( - const Vector&, const Vector&) const; + S2 FullMatrix::matrix_scalar_product( + const Vector&, const Vector&) const; template - void FullMatrix::forward( - Vector&, const Vector&) const; + void FullMatrix::forward( + Vector&, const Vector&) const; template - void FullMatrix::backward( - Vector&, const Vector&) const; + void FullMatrix::backward( + Vector&, const Vector&) const; template - void FullMatrix::precondition_Jacobi ( - Vector &, const Vector &, const S1) const; + void FullMatrix::precondition_Jacobi ( + Vector &, const Vector &, const S1) const; template - void FullMatrix::cholesky (const FullMatrix&); + void FullMatrix::cholesky (const FullMatrix&); template - void FullMatrix::outer_product (const Vector&, - const Vector&); - } + void FullMatrix::outer_product (const Vector&, + const Vector&); +} for (S1, S2, S3 : REAL_SCALARS) - { +{ template - S1 - FullMatrix::residual(Vector&, - const Vector&, - const Vector&) const; - } + S1 + FullMatrix::residual(Vector&, + const Vector&, + const Vector&) const; +} @@ -145,93 +145,93 @@ for (S1, S2, S3 : REAL_SCALARS) // same for complex scalars for (S : COMPLEX_SCALARS) - { +{ template class FullMatrix; template void FullMatrix::print( - LogStream&, const unsigned int, const unsigned int) const; + LogStream&, const unsigned int, const unsigned int) const; template void FullMatrix::print( - std::ostream&, const unsigned int, const unsigned int) const; - } + std::ostream&, const unsigned int, const unsigned int) const; +} for (S1, S2 : COMPLEX_SCALARS) - { +{ template - void FullMatrix::fill ( - const FullMatrix&, size_type, size_type, size_type, size_type); + void FullMatrix::fill ( + const FullMatrix&, size_type, size_type, size_type, size_type); template - void FullMatrix::add (const S1, const FullMatrix&); + void FullMatrix::add (const S1, const FullMatrix&); template - void FullMatrix::add (const S1, const FullMatrix&, - const S1, const FullMatrix&); + void FullMatrix::add (const S1, const FullMatrix&, + const S1, const FullMatrix&); template - void FullMatrix::add (const S1, const FullMatrix&, - const S1, const FullMatrix&, - const S1, const FullMatrix&); + void FullMatrix::add (const S1, const FullMatrix&, + const S1, const FullMatrix&, + const S1, const FullMatrix&); template - void FullMatrix::add ( - const FullMatrix&, S1, size_type, size_type, size_type, size_type); + void FullMatrix::add ( + const FullMatrix&, S1, size_type, size_type, size_type, size_type); template - void FullMatrix::Tadd (const S1, const FullMatrix&); + void FullMatrix::Tadd (const S1, const FullMatrix&); template - void FullMatrix::Tadd ( - const FullMatrix&, S1, size_type, size_type, - size_type, size_type); + void FullMatrix::Tadd ( + const FullMatrix&, S1, size_type, size_type, + size_type, size_type); template - void FullMatrix::equ (const S1, const FullMatrix&); + void FullMatrix::equ (const S1, const FullMatrix&); template - void FullMatrix::equ (const S1, const FullMatrix&, - const S1, const FullMatrix&); + void FullMatrix::equ (const S1, const FullMatrix&, + const S1, const FullMatrix&); template - void FullMatrix::equ (const S1, const FullMatrix&, - const S1, const FullMatrix&, - const S1, const FullMatrix&); + void FullMatrix::equ (const S1, const FullMatrix&, + const S1, const FullMatrix&, + const S1, const FullMatrix&); template - void FullMatrix::mmult (FullMatrix&, const FullMatrix&, const bool) const; + void FullMatrix::mmult (FullMatrix&, const FullMatrix&, const bool) const; template - void FullMatrix::Tmmult (FullMatrix&, const FullMatrix&, const bool) const; + void FullMatrix::Tmmult (FullMatrix&, const FullMatrix&, const bool) const; template - void FullMatrix::invert (const FullMatrix&); + void FullMatrix::invert (const FullMatrix&); - template - void FullMatrix::left_invert (const FullMatrix &); - template - void FullMatrix::right_invert (const FullMatrix &); + template + void FullMatrix::left_invert (const FullMatrix &); + template + void FullMatrix::right_invert (const FullMatrix &); template - void FullMatrix::fill_permutation ( - const FullMatrix&, - const std::vector&, - const std::vector&); + void FullMatrix::fill_permutation ( + const FullMatrix&, + const std::vector&, + const std::vector&); template - void FullMatrix::vmult( - Vector&, const Vector&, bool) const; + void FullMatrix::vmult( + Vector&, const Vector&, bool) const; template - void FullMatrix::Tvmult( - Vector&, const Vector&, bool) const; + void FullMatrix::Tvmult( + Vector&, const Vector&, bool) const; template - S2 FullMatrix::matrix_norm_square ( - const Vector &) const; + S2 FullMatrix::matrix_norm_square ( + const Vector &) const; template - S2 FullMatrix::matrix_scalar_product( - const Vector&, const Vector&) const; + S2 FullMatrix::matrix_scalar_product( + const Vector&, const Vector&) const; template - void FullMatrix::forward( - Vector&, const Vector&) const; + void FullMatrix::forward( + Vector&, const Vector&) const; template - void FullMatrix::backward( - Vector&, const Vector&) const; + void FullMatrix::backward( + Vector&, const Vector&) const; template - void FullMatrix::precondition_Jacobi ( - Vector &, const Vector &, const S1) const; - } + void FullMatrix::precondition_Jacobi ( + Vector &, const Vector &, const S1) const; +} for (S1, S2, S3 : COMPLEX_SCALARS) - { +{ template - S1 - FullMatrix::residual(Vector&, - const Vector&, - const Vector&) const; - } + S1 + FullMatrix::residual(Vector&, + const Vector&, + const Vector&) const; +} diff --git a/source/lac/la_parallel_block_vector.inst.in b/source/lac/la_parallel_block_vector.inst.in index adcb86666e..3cd1607100 100644 --- a/source/lac/la_parallel_block_vector.inst.in +++ b/source/lac/la_parallel_block_vector.inst.in @@ -17,25 +17,25 @@ for (SCALAR : REAL_SCALARS) { - namespace LinearAlgebra - \{ + namespace LinearAlgebra + \{ namespace distributed \{ - template class BlockVector; + template class BlockVector; + \} \} - \} } for (S1, S2 : REAL_SCALARS) { - namespace LinearAlgebra - \{ + namespace LinearAlgebra + \{ namespace distributed \{ - template void BlockVector::reinit (const BlockVector&, - const bool); - template void BlockVector::add (const std::vector &, - const ::dealii::Vector&); + template void BlockVector::reinit (const BlockVector&, + const bool); + template void BlockVector::add (const std::vector &, + const ::dealii::Vector&); + \} \} - \} } diff --git a/source/lac/la_parallel_vector.inst.in b/source/lac/la_parallel_vector.inst.in index 9b118a8acf..0453468d25 100644 --- a/source/lac/la_parallel_vector.inst.in +++ b/source/lac/la_parallel_vector.inst.in @@ -17,47 +17,47 @@ for (SCALAR : REAL_SCALARS) { - namespace LinearAlgebra - \{ + namespace LinearAlgebra + \{ namespace distributed \{ - template class Vector; + template class Vector; + \} \} - \} } for (S1, S2 : REAL_SCALARS) { - namespace LinearAlgebra - \{ + namespace LinearAlgebra + \{ namespace distributed \{ - template void Vector::reinit (const Vector&, - const bool); - template S1 Vector::inner_product_local (const Vector&) const; + template void Vector::reinit (const Vector&, + const bool); + template S1 Vector::inner_product_local (const Vector&) const; + \} \} - \} } for (SCALAR : COMPLEX_SCALARS) { - namespace LinearAlgebra - \{ + namespace LinearAlgebra + \{ namespace distributed \{ - template class Vector; + template class Vector; + \} \} - \} } for (S1, S2 : COMPLEX_SCALARS) { - namespace LinearAlgebra - \{ + namespace LinearAlgebra + \{ namespace distributed \{ - template void Vector::reinit (const Vector&, - const bool); + template void Vector::reinit (const Vector&, + const bool); + \} \} - \} } diff --git a/source/lac/la_vector.inst.in b/source/lac/la_vector.inst.in index 77324a3d57..4edc3ba886 100644 --- a/source/lac/la_vector.inst.in +++ b/source/lac/la_vector.inst.in @@ -16,14 +16,14 @@ for (SCALAR : REAL_SCALARS) - { +{ template class Vector; - } +} for (SCALAR : COMPLEX_SCALARS) - { +{ template class Vector; - } +} diff --git a/source/lac/lapack_full_matrix.inst.in b/source/lac/lapack_full_matrix.inst.in index 1b2958d53f..65d079e35d 100644 --- a/source/lac/lapack_full_matrix.inst.in +++ b/source/lac/lapack_full_matrix.inst.in @@ -16,16 +16,16 @@ for (S : REAL_SCALARS) - { +{ template class LAPACKFullMatrix; template class PreconditionLU; - } +} for (S1, S2 : REAL_SCALARS) - { +{ template LAPACKFullMatrix & LAPACKFullMatrix::operator = (const FullMatrix &M); template LAPACKFullMatrix & LAPACKFullMatrix::operator = (const SparseMatrix &M); - } +} diff --git a/source/lac/precondition_block.inst.in b/source/lac/precondition_block.inst.in index 9e44a1853a..dec1467d8b 100644 --- a/source/lac/precondition_block.inst.in +++ b/source/lac/precondition_block.inst.in @@ -16,74 +16,74 @@ for (S : REAL_SCALARS) - { +{ template class PreconditionBlockBase; - } +} for (S1, S2 : REAL_SCALARS) - { +{ template class PreconditionBlock, S2>; template class PreconditionBlockJacobi, S2>; template class PreconditionBlockSOR, S2>; template class PreconditionBlockSSOR, S2>; - } +} for (S1, S2, S3 : REAL_SCALARS) - { +{ // ------------ PreconditionBlockJacobi ----------------- template - void PreconditionBlockJacobi, S2>::vmult - (Vector &, const Vector &) const; + void PreconditionBlockJacobi, S2>::vmult + (Vector &, const Vector &) const; template - void PreconditionBlockJacobi, S2>::Tvmult - (Vector &, const Vector &) const; + void PreconditionBlockJacobi, S2>::Tvmult + (Vector &, const Vector &) const; template - void PreconditionBlockJacobi, S2>::vmult_add - (Vector &, const Vector &) const; + void PreconditionBlockJacobi, S2>::vmult_add + (Vector &, const Vector &) const; template - void PreconditionBlockJacobi, S2>::Tvmult_add - (Vector &, const Vector &) const; + void PreconditionBlockJacobi, S2>::Tvmult_add + (Vector &, const Vector &) const; template - void PreconditionBlockJacobi, S2>::step - (Vector &, const Vector &) const; + void PreconditionBlockJacobi, S2>::step + (Vector &, const Vector &) const; template - void PreconditionBlockJacobi, S2>::Tstep - (Vector &, const Vector &) const; + void PreconditionBlockJacobi, S2>::Tstep + (Vector &, const Vector &) const; // ------------ PreconditionBlockSOR ----------------- template - void PreconditionBlockSOR, S2>::vmult - (Vector &, const Vector &) const; + void PreconditionBlockSOR, S2>::vmult + (Vector &, const Vector &) const; template - void PreconditionBlockSOR, S2>::Tvmult - (Vector &, const Vector &) const; + void PreconditionBlockSOR, S2>::Tvmult + (Vector &, const Vector &) const; template - void PreconditionBlockSOR, S2>::vmult_add - (Vector &, const Vector &) const; + void PreconditionBlockSOR, S2>::vmult_add + (Vector &, const Vector &) const; template - void PreconditionBlockSOR, S2>::Tvmult_add - (Vector &, const Vector &) const; + void PreconditionBlockSOR, S2>::Tvmult_add + (Vector &, const Vector &) const; template - void PreconditionBlockSOR, S2>::step - (Vector &, const Vector &) const; + void PreconditionBlockSOR, S2>::step + (Vector &, const Vector &) const; template - void PreconditionBlockSOR, S2>::Tstep - (Vector &, const Vector &) const; + void PreconditionBlockSOR, S2>::Tstep + (Vector &, const Vector &) const; // ------------ PreconditionBlockSSOR ----------------- template - void PreconditionBlockSSOR, S2>::vmult - (Vector &, const Vector &) const; + void PreconditionBlockSSOR, S2>::vmult + (Vector &, const Vector &) const; template - void PreconditionBlockSSOR, S2>::Tvmult - (Vector &, const Vector &) const; + void PreconditionBlockSSOR, S2>::Tvmult + (Vector &, const Vector &) const; template - void PreconditionBlockSSOR, S2>::step - (Vector &, const Vector &) const; + void PreconditionBlockSSOR, S2>::step + (Vector &, const Vector &) const; template - void PreconditionBlockSSOR, S2>::Tstep - (Vector &, const Vector &) const; - } + void PreconditionBlockSSOR, S2>::Tstep + (Vector &, const Vector &) const; +} diff --git a/source/lac/read_write_vector.inst.in b/source/lac/read_write_vector.inst.in index dd83ecdbca..9cc7f21933 100644 --- a/source/lac/read_write_vector.inst.in +++ b/source/lac/read_write_vector.inst.in @@ -17,36 +17,36 @@ for (SCALAR : REAL_SCALARS) { - namespace LinearAlgebra - \{ + namespace LinearAlgebra + \{ template class ReadWriteVector; - \} + \} } for (S1, S2 : REAL_SCALARS) { - namespace LinearAlgebra - \{ + namespace LinearAlgebra + \{ template void ReadWriteVector::reinit (const ReadWriteVector&, - const bool); - \} + const bool); + \} } for (SCALAR : COMPLEX_SCALARS) { - namespace LinearAlgebra - \{ + namespace LinearAlgebra + \{ template class ReadWriteVector; - \} + \} } for (S1, S2 : COMPLEX_SCALARS) { - namespace LinearAlgebra - \{ + namespace LinearAlgebra + \{ template void ReadWriteVector::reinit (const ReadWriteVector&, - const bool); - \} + const bool); + \} } diff --git a/source/lac/relaxation_block.inst.in b/source/lac/relaxation_block.inst.in index dbd6b9b739..a013316e2c 100644 --- a/source/lac/relaxation_block.inst.in +++ b/source/lac/relaxation_block.inst.in @@ -16,38 +16,38 @@ for (S1, S2 : REAL_SCALARS) - { +{ template class RelaxationBlock, S2>; template class RelaxationBlockJacobi, S2>; template class RelaxationBlockSOR, S2>; template class RelaxationBlockSSOR, S2>; - } +} for (S1, S2, S3 : REAL_SCALARS) - { +{ // ------------ RelaxationBlockJacobi ----------------- template - void RelaxationBlockJacobi, S2>::step - (Vector &, const Vector &) const; + void RelaxationBlockJacobi, S2>::step + (Vector &, const Vector &) const; template - void RelaxationBlockJacobi, S2>::Tstep - (Vector &, const Vector &) const; + void RelaxationBlockJacobi, S2>::Tstep + (Vector &, const Vector &) const; // ------------ RelaxationBlockSOR ----------------- template - void RelaxationBlockSOR, S2>::step - (Vector &, const Vector &) const; + void RelaxationBlockSOR, S2>::step + (Vector &, const Vector &) const; template - void RelaxationBlockSOR, S2>::Tstep - (Vector &, const Vector &) const; + void RelaxationBlockSOR, S2>::Tstep + (Vector &, const Vector &) const; // ------------ RelaxationBlockSSOR ----------------- template - void RelaxationBlockSSOR, S2>::step - (Vector &, const Vector &) const; + void RelaxationBlockSSOR, S2>::step + (Vector &, const Vector &) const; template - void RelaxationBlockSSOR, S2>::Tstep - (Vector &, const Vector &) const; - } + void RelaxationBlockSSOR, S2>::Tstep + (Vector &, const Vector &) const; +} diff --git a/source/lac/solver.inst.in b/source/lac/solver.inst.in index 36650c9443..ec9664daf1 100644 --- a/source/lac/solver.inst.in +++ b/source/lac/solver.inst.in @@ -16,6 +16,6 @@ for (S : SERIAL_VECTORS) - { +{ template class Solver; - } +} diff --git a/source/lac/sparse_matrix.inst.in b/source/lac/sparse_matrix.inst.in index 010e8791f1..25b4911936 100644 --- a/source/lac/sparse_matrix.inst.in +++ b/source/lac/sparse_matrix.inst.in @@ -18,277 +18,277 @@ // real instantiations for (S : REAL_SCALARS) - { +{ template class SparseMatrix; - } +} for (S1, S2 : REAL_SCALARS) - { +{ template SparseMatrix & - SparseMatrix::copy_from (const SparseMatrix &); + SparseMatrix::copy_from (const SparseMatrix &); template - void SparseMatrix::copy_from (const FullMatrix &); + void SparseMatrix::copy_from (const FullMatrix &); template void SparseMatrix::add (const S1, - const SparseMatrix &); + const SparseMatrix &); template void SparseMatrix::add (const size_type, - const size_type, - const size_type *, - const S2 *, - const bool, - const bool); + const size_type, + const size_type *, + const S2 *, + const bool, + const bool); template void SparseMatrix::set (const size_type, - const size_type, - const size_type *, - const S2 *, - const bool); - } + const size_type, + const size_type *, + const S2 *, + const bool); +} for (S1, S2 : REAL_SCALARS) - { +{ template S2 - SparseMatrix:: - matrix_norm_square (const Vector &) const; + SparseMatrix:: + matrix_norm_square (const Vector &) const; template S2 - SparseMatrix:: - matrix_scalar_product (const Vector &, - const Vector &) const; + SparseMatrix:: + matrix_scalar_product (const Vector &, + const Vector &) const; template S2 SparseMatrix:: - residual (Vector &, - const Vector &, - const Vector &) const; + residual (Vector &, + const Vector &, + const Vector &) const; template void SparseMatrix:: - precondition_SSOR (Vector &, - const Vector &, - const S1, - const std::vector&) const; + precondition_SSOR (Vector &, + const Vector &, + const S1, + const std::vector&) const; template void SparseMatrix:: - precondition_SOR (Vector &, - const Vector &, - const S1) const; + precondition_SOR (Vector &, + const Vector &, + const S1) const; template void SparseMatrix:: - precondition_TSOR (Vector &, - const Vector &, - const S1) const; + precondition_TSOR (Vector &, + const Vector &, + const S1) const; template void SparseMatrix:: - precondition_Jacobi (Vector &, - const Vector &, - const S1) const; + precondition_Jacobi (Vector &, + const Vector &, + const S1) const; template void SparseMatrix:: - SOR (Vector &, - const S1) const; - template void SparseMatrix:: - TSOR (Vector &, - const S1) const; + SOR (Vector &, + const S1) const; template void SparseMatrix:: - SSOR (Vector &, - const S1) const; + TSOR (Vector &, + const S1) const; template void SparseMatrix:: - PSOR (Vector &, - const std::vector&, - const std::vector&, - const S1) const; + SSOR (Vector &, + const S1) const; template void SparseMatrix:: - TPSOR (Vector &, - const std::vector&, - const std::vector&, - const S1) const; + PSOR (Vector &, + const std::vector&, + const std::vector&, + const S1) const; template void SparseMatrix:: - Jacobi_step (Vector &, - const Vector &, - const S1) const; - template void SparseMatrix:: - SOR_step (Vector &, - const Vector &, - const S1) const; + TPSOR (Vector &, + const std::vector&, + const std::vector&, + const S1) const; template void SparseMatrix:: - TSOR_step (Vector &, + Jacobi_step (Vector &, const Vector &, const S1) const; template void SparseMatrix:: - SSOR_step (Vector &, - const Vector &, - const S1) const; - } + SOR_step (Vector &, + const Vector &, + const S1) const; + template void SparseMatrix:: + TSOR_step (Vector &, + const Vector &, + const S1) const; + template void SparseMatrix:: + SSOR_step (Vector &, + const Vector &, + const S1) const; +} for (S1, S2, S3 : REAL_SCALARS; - V1, V2 : DEAL_II_VEC_TEMPLATES) - { + V1, V2 : DEAL_II_VEC_TEMPLATES) +{ template void SparseMatrix:: - vmult (V1 &, const V2 &) const; + vmult (V1 &, const V2 &) const; template void SparseMatrix:: - Tvmult (V1 &, const V2 &) const; + Tvmult (V1 &, const V2 &) const; template void SparseMatrix:: - vmult_add (V1 &, const V2 &) const; + vmult_add (V1 &, const V2 &) const; template void SparseMatrix:: - Tvmult_add (V1 &, const V2 &) const; - } + Tvmult_add (V1 &, const V2 &) const; +} for (S1 : REAL_SCALARS) - { +{ template void SparseMatrix:: - vmult (LinearAlgebra::distributed::Vector &, const LinearAlgebra::distributed::Vector &) const; + vmult (LinearAlgebra::distributed::Vector &, const LinearAlgebra::distributed::Vector &) const; template void SparseMatrix:: - Tvmult (LinearAlgebra::distributed::Vector &, const LinearAlgebra::distributed::Vector &) const; + Tvmult (LinearAlgebra::distributed::Vector &, const LinearAlgebra::distributed::Vector &) const; template void SparseMatrix:: - vmult_add (LinearAlgebra::distributed::Vector &, const LinearAlgebra::distributed::Vector &) const; + vmult_add (LinearAlgebra::distributed::Vector &, const LinearAlgebra::distributed::Vector &) const; template void SparseMatrix:: - Tvmult_add (LinearAlgebra::distributed::Vector &, const LinearAlgebra::distributed::Vector &) const; - } + Tvmult_add (LinearAlgebra::distributed::Vector &, const LinearAlgebra::distributed::Vector &) const; +} for (S1, S2, S3: REAL_SCALARS) - { +{ template void SparseMatrix:: - mmult (SparseMatrix &, const SparseMatrix &, const Vector&, - const bool) const; + mmult (SparseMatrix &, const SparseMatrix &, const Vector&, + const bool) const; template void SparseMatrix:: - Tmmult (SparseMatrix &, const SparseMatrix &, const Vector&, - const bool) const; - } + Tmmult (SparseMatrix &, const SparseMatrix &, const Vector&, + const bool) const; +} // complex instantiations for (S : COMPLEX_SCALARS) - { +{ template class SparseMatrix; - } +} for (S1, S2 : COMPLEX_SCALARS) - { +{ template SparseMatrix & - SparseMatrix::copy_from (const SparseMatrix &); + SparseMatrix::copy_from (const SparseMatrix &); template - void SparseMatrix::copy_from (const FullMatrix &); + void SparseMatrix::copy_from (const FullMatrix &); template void SparseMatrix::add (const S1, - const SparseMatrix &); + const SparseMatrix &); template void SparseMatrix::add (const size_type, - const size_type, - const size_type *, - const S2 *, - const bool, - const bool); + const size_type, + const size_type *, + const S2 *, + const bool, + const bool); template void SparseMatrix::set (const size_type, - const size_type, - const size_type *, - const S2 *, - const bool); - } + const size_type, + const size_type *, + const S2 *, + const bool); +} for (S1, S2 : COMPLEX_SCALARS) - { +{ template S2 - SparseMatrix:: - matrix_norm_square (const Vector &) const; + SparseMatrix:: + matrix_norm_square (const Vector &) const; template S2 - SparseMatrix:: - matrix_scalar_product (const Vector &, - const Vector &) const; + SparseMatrix:: + matrix_scalar_product (const Vector &, + const Vector &) const; template S2 SparseMatrix:: - residual (Vector &, - const Vector &, - const Vector &) const; + residual (Vector &, + const Vector &, + const Vector &) const; template void SparseMatrix:: - precondition_SSOR (Vector &, - const Vector &, - const S1, - const std::vector&) const; + precondition_SSOR (Vector &, + const Vector &, + const S1, + const std::vector&) const; template void SparseMatrix:: - precondition_SOR (Vector &, - const Vector &, - const S1) const; + precondition_SOR (Vector &, + const Vector &, + const S1) const; template void SparseMatrix:: - precondition_TSOR (Vector &, - const Vector &, - const S1) const; + precondition_TSOR (Vector &, + const Vector &, + const S1) const; template void SparseMatrix:: - precondition_Jacobi (Vector &, - const Vector &, - const S1) const; + precondition_Jacobi (Vector &, + const Vector &, + const S1) const; template void SparseMatrix:: - SOR (Vector &, - const S1) const; - template void SparseMatrix:: - TSOR (Vector &, - const S1) const; + SOR (Vector &, + const S1) const; template void SparseMatrix:: - SSOR (Vector &, - const S1) const; + TSOR (Vector &, + const S1) const; template void SparseMatrix:: - PSOR (Vector &, - const std::vector&, - const std::vector&, - const S1) const; + SSOR (Vector &, + const S1) const; template void SparseMatrix:: - TPSOR (Vector &, - const std::vector&, - const std::vector&, - const S1) const; + PSOR (Vector &, + const std::vector&, + const std::vector&, + const S1) const; template void SparseMatrix:: - Jacobi_step (Vector &, - const Vector &, - const S1) const; - template void SparseMatrix:: - SOR_step (Vector &, - const Vector &, - const S1) const; + TPSOR (Vector &, + const std::vector&, + const std::vector&, + const S1) const; template void SparseMatrix:: - TSOR_step (Vector &, + Jacobi_step (Vector &, const Vector &, const S1) const; template void SparseMatrix:: - SSOR_step (Vector &, - const Vector &, - const S1) const; - } + SOR_step (Vector &, + const Vector &, + const S1) const; + template void SparseMatrix:: + TSOR_step (Vector &, + const Vector &, + const S1) const; + template void SparseMatrix:: + SSOR_step (Vector &, + const Vector &, + const S1) const; +} for (S1, S2, S3 : COMPLEX_SCALARS; - V1, V2 : DEAL_II_VEC_TEMPLATES) - { + V1, V2 : DEAL_II_VEC_TEMPLATES) +{ template void SparseMatrix:: - vmult (V1 &, const V2 &) const; + vmult (V1 &, const V2 &) const; template void SparseMatrix:: - Tvmult (V1 &, const V2 &) const; + Tvmult (V1 &, const V2 &) const; template void SparseMatrix:: - vmult_add (V1 &, const V2 &) const; + vmult_add (V1 &, const V2 &) const; template void SparseMatrix:: - Tvmult_add (V1 &, const V2 &) const; - } + Tvmult_add (V1 &, const V2 &) const; +} for (S1, S2, S3: COMPLEX_SCALARS) - { +{ template void SparseMatrix:: - mmult (SparseMatrix &, const SparseMatrix &, const Vector&, - const bool) const; + mmult (SparseMatrix &, const SparseMatrix &, const Vector&, + const bool) const; template void SparseMatrix:: - Tmmult (SparseMatrix &, const SparseMatrix &, const Vector&, - const bool) const; - } + Tmmult (SparseMatrix &, const SparseMatrix &, const Vector&, + const bool) const; +} diff --git a/source/lac/sparse_matrix_ez.inst.in b/source/lac/sparse_matrix_ez.inst.in index 9827253451..5629e6e7c5 100644 --- a/source/lac/sparse_matrix_ez.inst.in +++ b/source/lac/sparse_matrix_ez.inst.in @@ -16,42 +16,42 @@ for (S : REAL_SCALARS) - { +{ template class SparseMatrixEZ; - } +} for (S1, S2 : REAL_SCALARS) - { +{ template - void SparseMatrixEZ::vmult (Vector &, - const Vector &) const; + void SparseMatrixEZ::vmult (Vector &, + const Vector &) const; template - void SparseMatrixEZ::Tvmult (Vector &, - const Vector &) const; + void SparseMatrixEZ::Tvmult (Vector &, + const Vector &) const; template - void SparseMatrixEZ::vmult_add (Vector &, - const Vector &) const; + void SparseMatrixEZ::vmult_add (Vector &, + const Vector &) const; template - void SparseMatrixEZ::Tvmult_add (Vector &, - const Vector &) const; + void SparseMatrixEZ::Tvmult_add (Vector &, + const Vector &) const; template - void SparseMatrixEZ::precondition_SSOR (Vector &, - const Vector &, - const S1, - const std::vector&) const; + void SparseMatrixEZ::precondition_SSOR (Vector &, + const Vector &, + const S1, + const std::vector&) const; template - void SparseMatrixEZ::precondition_SOR (Vector &, - const Vector &, - const S1) const; + void SparseMatrixEZ::precondition_SOR (Vector &, + const Vector &, + const S1) const; template - void SparseMatrixEZ::precondition_TSOR (Vector &, - const Vector &, - const S1) const; + void SparseMatrixEZ::precondition_TSOR (Vector &, + const Vector &, + const S1) const; template - void SparseMatrixEZ::precondition_Jacobi (Vector &, - const Vector &, - const S1) const; - } + void SparseMatrixEZ::precondition_Jacobi (Vector &, + const Vector &, + const S1) const; +} diff --git a/source/lac/trilinos_sparse_matrix.inst.in b/source/lac/trilinos_sparse_matrix.inst.in index 0a96b56317..c7ddf87779 100644 --- a/source/lac/trilinos_sparse_matrix.inst.in +++ b/source/lac/trilinos_sparse_matrix.inst.in @@ -16,34 +16,34 @@ for (S : REAL_SCALARS) - { +{ namespace TrilinosWrappers \{ - template void - SparseMatrix::reinit (const dealii::SparseMatrix &, - const double, - const bool, - const dealii::SparsityPattern *); - template void - SparseMatrix::reinit (const Epetra_Map &, - const dealii::SparseMatrix &, - const double, - const bool, - const dealii::SparsityPattern *); - template void - SparseMatrix::reinit (const Epetra_Map &, - const Epetra_Map &, - const dealii::SparseMatrix &, - const double, - const bool, - const dealii::SparsityPattern *); - template void - SparseMatrix::reinit (const IndexSet &, - const IndexSet &, - const dealii::SparseMatrix &, - const MPI_Comm &, - const double, - const bool, - const dealii::SparsityPattern *); + template void + SparseMatrix::reinit (const dealii::SparseMatrix &, + const double, + const bool, + const dealii::SparsityPattern *); + template void + SparseMatrix::reinit (const Epetra_Map &, + const dealii::SparseMatrix &, + const double, + const bool, + const dealii::SparsityPattern *); + template void + SparseMatrix::reinit (const Epetra_Map &, + const Epetra_Map &, + const dealii::SparseMatrix &, + const double, + const bool, + const dealii::SparsityPattern *); + template void + SparseMatrix::reinit (const IndexSet &, + const IndexSet &, + const dealii::SparseMatrix &, + const MPI_Comm &, + const double, + const bool, + const dealii::SparsityPattern *); \} - } +} diff --git a/source/lac/trilinos_vector_base.inst.in b/source/lac/trilinos_vector_base.inst.in index 55898b4947..00fc2866bd 100644 --- a/source/lac/trilinos_vector_base.inst.in +++ b/source/lac/trilinos_vector_base.inst.in @@ -16,8 +16,8 @@ for (SCALAR : REAL_SCALARS) - { +{ template - VectorBase & - VectorBase::operator = (const ::dealii::Vector &v); - } + VectorBase & + VectorBase::operator = (const ::dealii::Vector &v); +} diff --git a/source/lac/vector.inst.in b/source/lac/vector.inst.in index 87af5f9299..e9c29f5856 100644 --- a/source/lac/vector.inst.in +++ b/source/lac/vector.inst.in @@ -16,44 +16,44 @@ for (SCALAR : REAL_SCALARS) - { +{ template class Vector; - } +} for (S1, S2 : REAL_SCALARS) - { +{ template - bool - Vector::operator==(const Vector&) const; + bool + Vector::operator==(const Vector&) const; template - S1 - Vector::operator*(const Vector&) const; + S1 + Vector::operator*(const Vector&) const; template - void Vector::reinit(const Vector&, const bool); - } + void Vector::reinit(const Vector&, const bool); +} for (SCALAR : COMPLEX_SCALARS) - { +{ template class Vector; - } +} for (S1, S2 : COMPLEX_SCALARS) - { +{ template - bool - Vector::operator==(const Vector&) const; + bool + Vector::operator==(const Vector&) const; template - S1 - Vector::operator*(const Vector&) const; + S1 + Vector::operator*(const Vector&) const; template - void Vector::reinit(const Vector&, const bool); - } + void Vector::reinit(const Vector&, const bool); +} for (S1: REAL_SCALARS; S2: COMPLEX_SCALARS) - { +{ template - Vector& Vector::operator= (const Vector &); - } + Vector& Vector::operator= (const Vector &); +} diff --git a/source/lac/vector_memory.inst.in b/source/lac/vector_memory.inst.in index 37fc030807..f05d649afa 100644 --- a/source/lac/vector_memory.inst.in +++ b/source/lac/vector_memory.inst.in @@ -16,16 +16,16 @@ for (VECTOR : SERIAL_VECTORS) - { +{ template class VectorMemory; template class GrowingVectorMemory; - } +} - for (SCALAR : COMPLEX_SCALARS) - { +for (SCALAR : COMPLEX_SCALARS) +{ template class VectorMemory >; template class GrowingVectorMemory >; template class VectorMemory >; template class GrowingVectorMemory >; - } +} diff --git a/source/lac/vector_view.inst.in b/source/lac/vector_view.inst.in index b7f376b666..1b874b3b28 100644 --- a/source/lac/vector_view.inst.in +++ b/source/lac/vector_view.inst.in @@ -16,11 +16,11 @@ for (SCALAR : REAL_SCALARS) - { +{ template class VectorView; - } +} for (SCALAR : COMPLEX_SCALARS) - { +{ template class VectorView; - } +} diff --git a/source/matrix_free/matrix_free.inst.in b/source/matrix_free/matrix_free.inst.in index f1feaf3d16..aaa35c70c8 100644 --- a/source/matrix_free/matrix_free.inst.in +++ b/source/matrix_free/matrix_free.inst.in @@ -16,28 +16,28 @@ for (deal_II_dimension : DIMENSIONS) { - template class MatrixFree; - template class MatrixFree; + template class MatrixFree; + template class MatrixFree; - template void MatrixFree:: - print_memory_consumption (std::ostream &) const; - template void MatrixFree:: - print_memory_consumption (ConditionalOStream &) const; + template void MatrixFree:: + print_memory_consumption (std::ostream &) const; + template void MatrixFree:: + print_memory_consumption (ConditionalOStream &) const; - template void MatrixFree:: - print_memory_consumption (std::ostream &) const; - template void MatrixFree:: - print_memory_consumption (ConditionalOStream &) const; + template void MatrixFree:: + print_memory_consumption (std::ostream &) const; + template void MatrixFree:: + print_memory_consumption (ConditionalOStream &) const; - template struct internal::MatrixFreeFunctions::MappingInfo; - template struct internal::MatrixFreeFunctions::MappingInfo; + template struct internal::MatrixFreeFunctions::MappingInfo; + template struct internal::MatrixFreeFunctions::MappingInfo; #ifndef DEAL_II_MSVC - template void internal::MatrixFreeFunctions::ShapeInfo::reinit - (const Quadrature<1> &, const FiniteElement - &, const unsigned int); - template void internal::MatrixFreeFunctions::ShapeInfo::reinit - (const Quadrature<1> &, const FiniteElement - &, const unsigned int); + template void internal::MatrixFreeFunctions::ShapeInfo::reinit + (const Quadrature<1> &, const FiniteElement + &, const unsigned int); + template void internal::MatrixFreeFunctions::ShapeInfo::reinit + (const Quadrature<1> &, const FiniteElement + &, const unsigned int); #endif } diff --git a/source/meshworker/mesh_worker_info.inst.in b/source/meshworker/mesh_worker_info.inst.in index 0b3e620e6e..2669f0999c 100644 --- a/source/meshworker/mesh_worker_info.inst.in +++ b/source/meshworker/mesh_worker_info.inst.in @@ -16,24 +16,24 @@ for (deal_II_dimension : DIMENSIONS) { -namespace MeshWorker -\{ - template class IntegrationInfo; - template class IntegrationInfoBox; + namespace MeshWorker + \{ + template class IntegrationInfo; + template class IntegrationInfoBox; - template class DoFInfo; - template class DoFInfoBox >; + template class DoFInfo; + template class DoFInfoBox >; - template void IntegrationInfo::fill_local_data( - const DoFInfo&, bool); + template void IntegrationInfo::fill_local_data( + const DoFInfo&, bool); - template class DoFInfo; - template class DoFInfoBox >; + template class DoFInfo; + template class DoFInfoBox >; - template void IntegrationInfo::fill_local_data( - const DoFInfo&, bool); + template void IntegrationInfo::fill_local_data( + const DoFInfo&, bool); // template void IntegrationInfo // ::initialize >( @@ -47,5 +47,5 @@ namespace MeshWorker // ::initialize >( // const FiniteElement&, const Mapping&, // const Quadrature::integral_dimension>&, const UpdateFlags, const BlockInfo*); -\} + \} } diff --git a/source/meshworker/mesh_worker_vector_selector.inst.in b/source/meshworker/mesh_worker_vector_selector.inst.in index 780484101a..454d790c43 100644 --- a/source/meshworker/mesh_worker_vector_selector.inst.in +++ b/source/meshworker/mesh_worker_vector_selector.inst.in @@ -17,19 +17,19 @@ for (deal_II_dimension : DIMENSIONS) { - namespace MeshWorker - \{ + namespace MeshWorker + \{ template class VectorDataBase; - \} + \} } for (VECTOR : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS) { - namespace MeshWorker - \{ + namespace MeshWorker + \{ template class VectorData; template class VectorData; template class MGVectorData; template class MGVectorData; - \} + \} } diff --git a/source/multigrid/mg_base.inst.in b/source/multigrid/mg_base.inst.in index a40aedb081..623bbfddf7 100644 --- a/source/multigrid/mg_base.inst.in +++ b/source/multigrid/mg_base.inst.in @@ -16,8 +16,8 @@ for (VEC : SERIAL_VECTORS) { - template class MGTransferBase< VEC >; - template class MGMatrixBase< VEC >; - template class MGSmootherBase< VEC >; - template class MGCoarseGridBase< VEC >; + template class MGTransferBase< VEC >; + template class MGMatrixBase< VEC >; + template class MGSmootherBase< VEC >; + template class MGCoarseGridBase< VEC >; } diff --git a/source/multigrid/mg_level_global_transfer.inst.in b/source/multigrid/mg_level_global_transfer.inst.in index 908bb1b665..64a1f9bd9a 100644 --- a/source/multigrid/mg_level_global_transfer.inst.in +++ b/source/multigrid/mg_level_global_transfer.inst.in @@ -16,62 +16,62 @@ for (V1 : VECTORS_WITH_MATRIX) - { +{ template class MGLevelGlobalTransfer< V1 >; - } +} for (deal_II_dimension : DIMENSIONS; V1 : VECTORS_WITH_MATRIX) - { +{ template - void MGLevelGlobalTransfer< V1 >::fill_and_communicate_copy_indices( + void MGLevelGlobalTransfer< V1 >::fill_and_communicate_copy_indices( const DoFHandler &mg_dof); - } +} for (deal_II_dimension : DIMENSIONS; V1,V2 : DEAL_II_VEC_TEMPLATES; S1, S2 : REAL_SCALARS) - { +{ template void - MGLevelGlobalTransfer >::copy_to_mg ( + MGLevelGlobalTransfer >::copy_to_mg ( const DoFHandler&, MGLevelObject >&, const V2&) const; template void - MGLevelGlobalTransfer >::copy_from_mg (const DoFHandler&, V2&, - const MGLevelObject >&) const; + MGLevelGlobalTransfer >::copy_from_mg (const DoFHandler&, V2&, + const MGLevelObject >&) const; template void - MGLevelGlobalTransfer >::copy_from_mg_add (const DoFHandler&, V2&, - const MGLevelObject >&) const; - } + MGLevelGlobalTransfer >::copy_from_mg_add (const DoFHandler&, V2&, + const MGLevelObject >&) const; +} for (deal_II_dimension : DIMENSIONS) - { +{ template - void MGLevelGlobalTransfer< LinearAlgebra::distributed::Vector >::fill_and_communicate_copy_indices( + void MGLevelGlobalTransfer< LinearAlgebra::distributed::Vector >::fill_and_communicate_copy_indices( const DoFHandler &mg_dof); - } +} for (deal_II_dimension : DIMENSIONS; S1, S2 : REAL_SCALARS) - { +{ template void - MGLevelGlobalTransfer >::copy_to_mg ( + MGLevelGlobalTransfer >::copy_to_mg ( const DoFHandler&, MGLevelObject >&, const LinearAlgebra::distributed::Vector&) const; template void - MGLevelGlobalTransfer >::copy_from_mg (const DoFHandler&, LinearAlgebra::distributed::Vector&, - const MGLevelObject >&) const; + MGLevelGlobalTransfer >::copy_from_mg (const DoFHandler&, LinearAlgebra::distributed::Vector&, + const MGLevelObject >&) const; template void - MGLevelGlobalTransfer >::copy_from_mg_add (const DoFHandler&, LinearAlgebra::distributed::Vector&, - const MGLevelObject >&) const; - } + MGLevelGlobalTransfer >::copy_from_mg_add (const DoFHandler&, LinearAlgebra::distributed::Vector&, + const MGLevelObject >&) const; +} for(deal_II_dimension : DIMENSIONS) - { +{ #ifdef DEAL_II_WITH_TRILINOS template void - MGLevelGlobalTransfer::copy_to_mg ( + MGLevelGlobalTransfer::copy_to_mg ( const DoFHandler&, MGLevelObject&, const TrilinosWrappers::MPI::Vector&) const; template void - MGLevelGlobalTransfer::copy_from_mg (const DoFHandler&, TrilinosWrappers::MPI::Vector&, - const MGLevelObject&) const; + MGLevelGlobalTransfer::copy_from_mg (const DoFHandler&, TrilinosWrappers::MPI::Vector&, + const MGLevelObject&) const; template void - MGLevelGlobalTransfer::copy_from_mg_add (const DoFHandler&, TrilinosWrappers::MPI::Vector&, - const MGLevelObject&) const; + MGLevelGlobalTransfer::copy_from_mg_add (const DoFHandler&, TrilinosWrappers::MPI::Vector&, + const MGLevelObject&) const; #endif - } +} diff --git a/source/multigrid/mg_tools.inst.in b/source/multigrid/mg_tools.inst.in index 2876c42cda..ab3f89ec43 100644 --- a/source/multigrid/mg_tools.inst.in +++ b/source/multigrid/mg_tools.inst.in @@ -16,48 +16,48 @@ for (PATTERN : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS; - deal_II_space_dimension: SPACE_DIMENSIONS) - { + deal_II_space_dimension: SPACE_DIMENSIONS) +{ namespace MGTools - \{ + \{ #if deal_II_dimension <= deal_II_space_dimension - template void - make_sparsity_pattern, PATTERN> ( - const DoFHandler &, - PATTERN &, - const unsigned int); + template void + make_sparsity_pattern, PATTERN> ( + const DoFHandler &, + PATTERN &, + const unsigned int); #endif #if deal_II_dimension == deal_II_space_dimension template void - make_flux_sparsity_pattern ( - const DoFHandler &, - PATTERN &, - const unsigned int); + make_flux_sparsity_pattern ( + const DoFHandler &, + PATTERN &, + const unsigned int); template void - make_flux_sparsity_pattern_edge ( - const DoFHandler &, - PATTERN &, - const unsigned int); + make_flux_sparsity_pattern_edge ( + const DoFHandler &, + PATTERN &, + const unsigned int); #if deal_II_dimension > 1 template void - make_flux_sparsity_pattern ( - const DoFHandler &, - PATTERN &, - const unsigned int, - const Table<2,DoFTools::Coupling>&, - const Table<2,DoFTools::Coupling>&); + make_flux_sparsity_pattern ( + const DoFHandler &, + PATTERN &, + const unsigned int, + const Table<2,DoFTools::Coupling>&, + const Table<2,DoFTools::Coupling>&); template void - make_flux_sparsity_pattern_edge ( - const DoFHandler &, - PATTERN &, - const unsigned int, - const Table<2,DoFTools::Coupling>&); + make_flux_sparsity_pattern_edge ( + const DoFHandler &, + PATTERN &, + const unsigned int, + const Table<2,DoFTools::Coupling>&); #endif #endif \} @@ -65,42 +65,42 @@ for (PATTERN : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS; for (deal_II_dimension : DIMENSIONS) - { +{ namespace MGTools \{ #if deal_II_dimension > 1 - template void - compute_row_length_vector( - const DoFHandler&, unsigned int, - std::vector&, const DoFTools::Coupling); - template void - compute_row_length_vector( - const DoFHandler&, unsigned int, - std::vector&, - const Table<2,DoFTools::Coupling>&, const Table<2,DoFTools::Coupling>&); + template void + compute_row_length_vector( + const DoFHandler&, unsigned int, + std::vector&, const DoFTools::Coupling); + template void + compute_row_length_vector( + const DoFHandler&, unsigned int, + std::vector&, + const Table<2,DoFTools::Coupling>&, const Table<2,DoFTools::Coupling>&); #endif - template void count_dofs_per_component ( - const DoFHandler&, std::vector >&, - bool, std::vector); - template void count_dofs_per_block ( - const DoFHandler&, std::vector >&, - std::vector); + template void count_dofs_per_component ( + const DoFHandler&, std::vector >&, + bool, std::vector); + template void count_dofs_per_block ( + const DoFHandler&, std::vector >&, + std::vector); #if deal_II_dimension > 1 - template void make_boundary_list( - const DoFHandler&, - const FunctionMap::type&, - std::vector >&, - const ComponentMask &); + template void make_boundary_list( + const DoFHandler&, + const FunctionMap::type&, + std::vector >&, + const ComponentMask &); #endif template void make_boundary_list( - const DoFHandler&, - const FunctionMap::type&, - std::vector&, - const ComponentMask &); + const DoFHandler&, + const FunctionMap::type&, + std::vector&, + const ComponentMask &); template void make_boundary_list( const DoFHandler &, @@ -109,27 +109,27 @@ for (deal_II_dimension : DIMENSIONS) const ComponentMask &); - template - void - extract_inner_interface_dofs (const DoFHandler &mg_dof_handler, - std::vector &interface_dofs); + template + void + extract_inner_interface_dofs (const DoFHandler &mg_dof_handler, + std::vector &interface_dofs); - template - void - extract_non_interface_dofs (const DoFHandler & mg_dof_handler, - std::vector > &non_interface_dofs); + template + void + extract_non_interface_dofs (const DoFHandler & mg_dof_handler, + std::vector > &non_interface_dofs); #if deal_II_dimension < 3 - template void count_dofs_per_block ( - const DoFHandler&, - std::vector >&, std::vector); + template void count_dofs_per_block ( + const DoFHandler&, + std::vector >&, std::vector); #endif #if deal_II_dimension == 3 - template void count_dofs_per_block ( - const DoFHandler<1,3>&, - std::vector >&, std::vector); + template void count_dofs_per_block ( + const DoFHandler<1,3>&, + std::vector >&, std::vector); #endif \} - } +} diff --git a/source/multigrid/mg_transfer_block.inst.in b/source/multigrid/mg_transfer_block.inst.in index d44ef27b77..d76c7f4bdb 100644 --- a/source/multigrid/mg_transfer_block.inst.in +++ b/source/multigrid/mg_transfer_block.inst.in @@ -16,119 +16,119 @@ for (deal_II_dimension : DIMENSIONS) - { -template -void MGTransferBlock::build_matrices -(const DoFHandler&, const DoFHandler&, - const std::vector&); +{ + template + void MGTransferBlock::build_matrices + (const DoFHandler&, const DoFHandler&, + const std::vector&); -template -void MGTransferBlock::build_matrices -(const DoFHandler&, const DoFHandler&, - const std::vector&); + template + void MGTransferBlock::build_matrices + (const DoFHandler&, const DoFHandler&, + const std::vector&); -template -void MGTransferBlockSelect::build_matrices -(const DoFHandler&, const DoFHandler&, - const unsigned int); + template + void MGTransferBlockSelect::build_matrices + (const DoFHandler&, const DoFHandler&, + const unsigned int); -template -void MGTransferBlockSelect::build_matrices -(const DoFHandler&, const DoFHandler&, - const unsigned int); + template + void MGTransferBlockSelect::build_matrices + (const DoFHandler&, const DoFHandler&, + const unsigned int); -template void -MGTransferBlock::copy_to_mg ( - const DoFHandler&, - MGLevelObject >&, - const BlockVector&) const; -template void -MGTransferBlock::copy_from_mg ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; -template void -MGTransferBlock::copy_from_mg_add ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; + template void + MGTransferBlock::copy_to_mg ( + const DoFHandler&, + MGLevelObject >&, + const BlockVector&) const; + template void + MGTransferBlock::copy_from_mg ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; + template void + MGTransferBlock::copy_from_mg_add ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; -template void -MGTransferBlock::copy_to_mg ( - const DoFHandler&, - MGLevelObject >&, - const BlockVector&) const; -template void -MGTransferBlock::copy_from_mg ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; -template void -MGTransferBlock::copy_from_mg_add ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; + template void + MGTransferBlock::copy_to_mg ( + const DoFHandler&, + MGLevelObject >&, + const BlockVector&) const; + template void + MGTransferBlock::copy_from_mg ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; + template void + MGTransferBlock::copy_from_mg_add ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; -template void -MGTransferBlockSelect::copy_to_mg ( - const DoFHandler&, - MGLevelObject >&, - const Vector&) const; -template void -MGTransferBlockSelect::copy_to_mg ( - const DoFHandler&, - MGLevelObject >&, - const BlockVector&) const; -template void -MGTransferBlockSelect::copy_from_mg ( - const DoFHandler&, - Vector&, - const MGLevelObject >&) const; -template void -MGTransferBlockSelect::copy_from_mg ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; -template void -MGTransferBlockSelect::copy_from_mg_add ( - const DoFHandler&, - Vector&, - const MGLevelObject >&) const; -template void -MGTransferBlockSelect::copy_from_mg_add ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; + template void + MGTransferBlockSelect::copy_to_mg ( + const DoFHandler&, + MGLevelObject >&, + const Vector&) const; + template void + MGTransferBlockSelect::copy_to_mg ( + const DoFHandler&, + MGLevelObject >&, + const BlockVector&) const; + template void + MGTransferBlockSelect::copy_from_mg ( + const DoFHandler&, + Vector&, + const MGLevelObject >&) const; + template void + MGTransferBlockSelect::copy_from_mg ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; + template void + MGTransferBlockSelect::copy_from_mg_add ( + const DoFHandler&, + Vector&, + const MGLevelObject >&) const; + template void + MGTransferBlockSelect::copy_from_mg_add ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; -template void -MGTransferBlockSelect::copy_to_mg ( - const DoFHandler&, - MGLevelObject >&, - const Vector&) const; -template void -MGTransferBlockSelect::copy_to_mg ( - const DoFHandler&, - MGLevelObject >&, - const BlockVector&) const; -template void -MGTransferBlockSelect::copy_from_mg ( - const DoFHandler&, - Vector&, - const MGLevelObject >&) const; -template void -MGTransferBlockSelect::copy_from_mg ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; -template void -MGTransferBlockSelect::copy_from_mg_add ( - const DoFHandler&, - Vector&, - const MGLevelObject >&) const; -template void -MGTransferBlockSelect::copy_from_mg_add ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; - } + template void + MGTransferBlockSelect::copy_to_mg ( + const DoFHandler&, + MGLevelObject >&, + const Vector&) const; + template void + MGTransferBlockSelect::copy_to_mg ( + const DoFHandler&, + MGLevelObject >&, + const BlockVector&) const; + template void + MGTransferBlockSelect::copy_from_mg ( + const DoFHandler&, + Vector&, + const MGLevelObject >&) const; + template void + MGTransferBlockSelect::copy_from_mg ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; + template void + MGTransferBlockSelect::copy_from_mg_add ( + const DoFHandler&, + Vector&, + const MGLevelObject >&) const; + template void + MGTransferBlockSelect::copy_from_mg_add ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; +} diff --git a/source/multigrid/mg_transfer_component.inst.in b/source/multigrid/mg_transfer_component.inst.in index e7036ed4db..4dc0421658 100644 --- a/source/multigrid/mg_transfer_component.inst.in +++ b/source/multigrid/mg_transfer_component.inst.in @@ -16,85 +16,85 @@ for (deal_II_dimension : DIMENSIONS) - { -template -void MGTransferSelect::build_matrices -(const DoFHandler &d, - const DoFHandler &, - unsigned int, unsigned int, - const std::vector&, - const std::vector&, - const std::vector >&); +{ + template + void MGTransferSelect::build_matrices + (const DoFHandler &d, + const DoFHandler &, + unsigned int, unsigned int, + const std::vector&, + const std::vector&, + const std::vector >&); -template -void MGTransferSelect::build_matrices -(const DoFHandler &d, - const DoFHandler &, - unsigned int, unsigned int, - const std::vector&, - const std::vector&, - const std::vector >&); + template + void MGTransferSelect::build_matrices + (const DoFHandler &d, + const DoFHandler &, + unsigned int, unsigned int, + const std::vector&, + const std::vector&, + const std::vector >&); -template void -MGTransferSelect::copy_to_mg ( - const DoFHandler&, - MGLevelObject >&, - const Vector&) const; -template void -MGTransferSelect::copy_to_mg ( - const DoFHandler&, - MGLevelObject >&, - const BlockVector&) const; -template void -MGTransferSelect::copy_from_mg ( - const DoFHandler&, - Vector&, - const MGLevelObject >&) const; -template void -MGTransferSelect::copy_from_mg ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; -template void -MGTransferSelect::copy_from_mg_add ( - const DoFHandler&, - Vector&, - const MGLevelObject >&) const; -template void -MGTransferSelect::copy_from_mg_add ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; + template void + MGTransferSelect::copy_to_mg ( + const DoFHandler&, + MGLevelObject >&, + const Vector&) const; + template void + MGTransferSelect::copy_to_mg ( + const DoFHandler&, + MGLevelObject >&, + const BlockVector&) const; + template void + MGTransferSelect::copy_from_mg ( + const DoFHandler&, + Vector&, + const MGLevelObject >&) const; + template void + MGTransferSelect::copy_from_mg ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; + template void + MGTransferSelect::copy_from_mg_add ( + const DoFHandler&, + Vector&, + const MGLevelObject >&) const; + template void + MGTransferSelect::copy_from_mg_add ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; -template void -MGTransferSelect::copy_to_mg ( - const DoFHandler&, - MGLevelObject >&, - const Vector&) const; -template void -MGTransferSelect::copy_to_mg ( - const DoFHandler&, - MGLevelObject >&, - const BlockVector&) const; -template void -MGTransferSelect::copy_from_mg ( - const DoFHandler&, - Vector&, - const MGLevelObject >&) const; -template void -MGTransferSelect::copy_from_mg ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; -template void -MGTransferSelect::copy_from_mg_add ( - const DoFHandler&, - Vector&, - const MGLevelObject >&) const; -template void -MGTransferSelect::copy_from_mg_add ( - const DoFHandler&, - BlockVector&, - const MGLevelObject >&) const; - } + template void + MGTransferSelect::copy_to_mg ( + const DoFHandler&, + MGLevelObject >&, + const Vector&) const; + template void + MGTransferSelect::copy_to_mg ( + const DoFHandler&, + MGLevelObject >&, + const BlockVector&) const; + template void + MGTransferSelect::copy_from_mg ( + const DoFHandler&, + Vector&, + const MGLevelObject >&) const; + template void + MGTransferSelect::copy_from_mg ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; + template void + MGTransferSelect::copy_from_mg_add ( + const DoFHandler&, + Vector&, + const MGLevelObject >&) const; + template void + MGTransferSelect::copy_from_mg_add ( + const DoFHandler&, + BlockVector&, + const MGLevelObject >&) const; +} diff --git a/source/multigrid/mg_transfer_matrix_free.inst.in b/source/multigrid/mg_transfer_matrix_free.inst.in index 184183d3e8..719e19d8e5 100644 --- a/source/multigrid/mg_transfer_matrix_free.inst.in +++ b/source/multigrid/mg_transfer_matrix_free.inst.in @@ -16,6 +16,6 @@ for (deal_II_dimension : DIMENSIONS; S1 : REAL_SCALARS) - { +{ template class MGTransferMatrixFree< deal_II_dimension, S1 >; - } +} diff --git a/source/multigrid/mg_transfer_prebuilt.inst.in b/source/multigrid/mg_transfer_prebuilt.inst.in index 7b5da44ab9..7299c82e31 100644 --- a/source/multigrid/mg_transfer_prebuilt.inst.in +++ b/source/multigrid/mg_transfer_prebuilt.inst.in @@ -16,13 +16,13 @@ for (V1 : VECTORS_WITH_MATRIX) - { +{ template class MGTransferPrebuilt< V1 >; - } +} for (deal_II_dimension : DIMENSIONS; V1 : VECTORS_WITH_MATRIX) - { +{ template - void MGTransferPrebuilt< V1 >::build_matrices( + void MGTransferPrebuilt< V1 >::build_matrices( const DoFHandler &mg_dof); - } +} diff --git a/source/multigrid/multigrid.inst.in b/source/multigrid/multigrid.inst.in index 49c2db02bb..a368cb9227 100644 --- a/source/multigrid/multigrid.inst.in +++ b/source/multigrid/multigrid.inst.in @@ -16,5 +16,5 @@ for (VEC : SERIAL_VECTORS) { - template class Multigrid< VEC >; + template class Multigrid< VEC >; } diff --git a/source/numerics/data_out.inst.in b/source/numerics/data_out.inst.in index 2271d25a9d..904fd1f77f 100644 --- a/source/numerics/data_out.inst.in +++ b/source/numerics/data_out.inst.in @@ -17,24 +17,24 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : DIMENSIONS) { - namespace internal \{ + namespace internal \{ namespace DataOut \{ #if deal_II_dimension <= deal_II_space_dimension - template struct ParallelData; + template struct ParallelData; #endif \} - \} + \} } for (DH : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS) { - template class DataOut >; - #if deal_II_dimension < 3 - template class DataOut >; - #endif + template class DataOut >; +#if deal_II_dimension < 3 + template class DataOut >; +#endif - #if deal_II_dimension == 3 - template class DataOut<1, DH<1,3> >; - #endif +#if deal_II_dimension == 3 + template class DataOut<1, DH<1,3> >; +#endif } \ No newline at end of file diff --git a/source/numerics/data_out_dof_data.inst.in b/source/numerics/data_out_dof_data.inst.in index 7f76086351..2b7f748fbe 100644 --- a/source/numerics/data_out_dof_data.inst.in +++ b/source/numerics/data_out_dof_data.inst.in @@ -18,221 +18,221 @@ for (VEC : REAL_SERIAL_VECTORS; DH : DOFHANDLER_TEMPLATES; deal_II_dimension : D { // codim=0 - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const VEC &, - const std::string &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const VEC &, - const std::vector &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const VEC &, - const DataPostprocessor::space_dimension> &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const DH &, - const VEC &, - const std::string &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const DH &, - const VEC &, - const std::vector &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const DH &, - const VEC &, - const DataPostprocessor::space_dimension> &); + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const VEC &, + const std::string &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const VEC &, + const std::vector &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const VEC &, + const DataPostprocessor::space_dimension> &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const DH &, + const VEC &, + const std::string &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const DH &, + const VEC &, + const std::vector &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const DH &, + const VEC &, + const DataPostprocessor::space_dimension> &); // stuff needed for face data - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const VEC &, - const std::string &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const VEC &, - const std::vector &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const VEC &, - const DataPostprocessor::space_dimension> &); - - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const DH &, - const VEC &, - const std::string &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const DH &, - const VEC &, - const std::vector &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const DH &, - const VEC &, - const DataPostprocessor::space_dimension> &); + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const VEC &, + const std::string &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const VEC &, + const std::vector &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const VEC &, + const DataPostprocessor::space_dimension> &); + + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const DH &, + const VEC &, + const std::string &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const DH &, + const VEC &, + const std::vector &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const DH &, + const VEC &, + const DataPostprocessor::space_dimension> &); // things for DataOutRotation #if deal_II_dimension < 3 - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const VEC &, - const std::string &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const VEC &, - const std::vector &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const VEC &, - const DataPostprocessor::space_dimension> &); - - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const DH &, - const VEC &, - const std::string &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const DH &, - const VEC &, - const std::vector &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const DH &, - const VEC &, - const DataPostprocessor::space_dimension> &); + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const VEC &, + const std::string &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const VEC &, + const std::vector &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const VEC &, + const DataPostprocessor::space_dimension> &); + + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const DH &, + const VEC &, + const std::string &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const DH &, + const VEC &, + const std::vector &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const DH &, + const VEC &, + const DataPostprocessor::space_dimension> &); #endif // codim 1 #if deal_II_dimension < 3 - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: - add_data_vector (const VEC &, - const std::string &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: - add_data_vector (const VEC &, - const std::vector &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: - add_data_vector (const VEC &, - const DataPostprocessor::space_dimension> &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: - add_data_vector (const DH &, - const VEC &, - const std::string &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: - add_data_vector (const DH &, - const VEC &, - const std::vector &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: - add_data_vector (const DH &, - const VEC &, - const DataPostprocessor::space_dimension> &); + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: + add_data_vector (const VEC &, + const std::string &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: + add_data_vector (const VEC &, + const std::vector &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: + add_data_vector (const VEC &, + const DataPostprocessor::space_dimension> &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: + add_data_vector (const DH &, + const VEC &, + const std::string &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: + add_data_vector (const DH &, + const VEC &, + const std::vector &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: + add_data_vector (const DH &, + const VEC &, + const DataPostprocessor::space_dimension> &); #endif // codim 2 - #if deal_II_dimension == 3 - template void - DataOut_DoFData,1,3>:: - add_data_vector (const VEC &, - const std::string &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,1,3>:: - add_data_vector (const VEC &, - const std::vector &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,1,3>:: - add_data_vector (const VEC &, - const DataPostprocessor::space_dimension> &); - - template void - DataOut_DoFData,1,3>:: - add_data_vector (const DH<1,3> &, - const VEC &, - const std::string &, - const std::vector &); - - template void - DataOut_DoFData,1,3>:: - add_data_vector (const DH<1,3> &, - const VEC &, - const std::vector &, - const std::vector &); - - template void - DataOut_DoFData,1,3>:: - add_data_vector (const DH<1,3> &, - const VEC &, - const DataPostprocessor::space_dimension> &); - #endif +#if deal_II_dimension == 3 + template void + DataOut_DoFData,1,3>:: + add_data_vector (const VEC &, + const std::string &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,1,3>:: + add_data_vector (const VEC &, + const std::vector &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,1,3>:: + add_data_vector (const VEC &, + const DataPostprocessor::space_dimension> &); + + template void + DataOut_DoFData,1,3>:: + add_data_vector (const DH<1,3> &, + const VEC &, + const std::string &, + const std::vector &); + + template void + DataOut_DoFData,1,3>:: + add_data_vector (const DH<1,3> &, + const VEC &, + const std::vector &, + const std::vector &); + + template void + DataOut_DoFData,1,3>:: + add_data_vector (const DH<1,3> &, + const VEC &, + const DataPostprocessor::space_dimension> &); +#endif } @@ -242,136 +242,136 @@ for (DH : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS) { // codim=0 - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const IndexSet &, - const std::string &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const IndexSet &, - const std::vector &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const DH &, - const IndexSet &, - const std::string &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const DH &, - const IndexSet &, - const std::vector &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: - add_data_vector (const IndexSet &, - const DataPostprocessor::space_dimension> &); + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const IndexSet &, + const std::string &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const IndexSet &, + const std::vector &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const DH &, + const IndexSet &, + const std::string &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const DH &, + const IndexSet &, + const std::vector &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension>:: + add_data_vector (const IndexSet &, + const DataPostprocessor::space_dimension> &); // stuff needed for face data - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const IndexSet &, - const std::string &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const IndexSet &, - const std::vector &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const IndexSet &, - const DataPostprocessor::space_dimension> &); - - - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const DH &, - const IndexSet &, - const std::string &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: - add_data_vector (const DH &, - const IndexSet &, - const std::vector &, - const std::vector &); + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const IndexSet &, + const std::string &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const IndexSet &, + const std::vector &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const IndexSet &, + const DataPostprocessor::space_dimension> &); + + + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const DH &, + const IndexSet &, + const std::string &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>:: + add_data_vector (const DH &, + const IndexSet &, + const std::vector &, + const std::vector &); // things for DataOutRotation #if deal_II_dimension < 3 - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const IndexSet &, - const std::string &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const IndexSet &, - const std::vector &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const IndexSet &, - const DataPostprocessor::space_dimension> &); - - - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const DH &, - const IndexSet &, - const std::string &, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: - add_data_vector (const DH &, - const IndexSet &, - const std::vector &, - const std::vector &); + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const IndexSet &, + const std::string &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const IndexSet &, + const std::vector &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const IndexSet &, + const DataPostprocessor::space_dimension> &); + + + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const DH &, + const IndexSet &, + const std::string &, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension+1,deal_II_dimension+1>:: + add_data_vector (const DH &, + const IndexSet &, + const std::vector &, + const std::vector &); #endif // codim 1 #if deal_II_dimension < 3 - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: - add_data_vector (const IndexSet &, - const std::string &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: - add_data_vector (const IndexSet &, - const std::vector &, - const DataVectorType, - const std::vector &); - - template void - DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: - add_data_vector (const IndexSet &, - const DataPostprocessor::space_dimension> &); + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: + add_data_vector (const IndexSet &, + const std::string &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: + add_data_vector (const IndexSet &, + const std::vector &, + const DataVectorType, + const std::vector &); + + template void + DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>:: + add_data_vector (const IndexSet &, + const DataPostprocessor::space_dimension> &); #endif } @@ -380,21 +380,21 @@ for (DH : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS) for (DH : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS) { - template class DataOut_DoFData,deal_II_dimension>; + template class DataOut_DoFData,deal_II_dimension>; #if deal_II_dimension < 3 - template class DataOut_DoFData,deal_II_dimension+1>; - template class DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>; - template class DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>; + template class DataOut_DoFData,deal_II_dimension+1>; + template class DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>; + template class DataOut_DoFData,deal_II_dimension,deal_II_dimension+1>; #endif #if deal_II_dimension >= 2 - template class DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>; + template class DataOut_DoFData,deal_II_dimension-1,deal_II_dimension>; #endif #if deal_II_dimension == 3 - template class DataOut_DoFData,1,3>; - template class DataOut_DoFData,1,3>; + template class DataOut_DoFData,1,3>; + template class DataOut_DoFData,1,3>; #endif } @@ -402,29 +402,29 @@ for (DH : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS) for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : DIMENSIONS) { - namespace internal \{ + namespace internal \{ namespace DataOut \{ #if deal_II_dimension <= deal_II_space_dimension - template struct ParallelDataBase; + template struct ParallelDataBase; #endif \} - \} + \} } for (DH : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : DIMENSIONS) { - namespace internal \{ + namespace internal \{ namespace DataOut \{ #if deal_II_dimension <= deal_II_space_dimension - template - void - ParallelDataBase:: - reinit_all_fe_values > - (std::vector > > > &dof_data, - const dealii::Triangulation::cell_iterator &cell, - const unsigned int face); + template + void + ParallelDataBase:: + reinit_all_fe_values > + (std::vector > > > &dof_data, + const dealii::Triangulation::cell_iterator &cell, + const unsigned int face); #endif \} - \} + \} } diff --git a/source/numerics/data_out_faces.inst.in b/source/numerics/data_out_faces.inst.in index 114a6b3d79..302a996757 100644 --- a/source/numerics/data_out_faces.inst.in +++ b/source/numerics/data_out_faces.inst.in @@ -16,9 +16,9 @@ for (deal_II_dimension : DIMENSIONS) { - // don't instantiate anything for the 1d + // don't instantiate anything for the 1d #if deal_II_dimension >=2 - template class DataOutFaces >; - template class DataOutFaces >; + template class DataOutFaces >; + template class DataOutFaces >; #endif } diff --git a/source/numerics/data_out_rotation.inst.in b/source/numerics/data_out_rotation.inst.in index ecc3a6e0be..c4988d7d96 100644 --- a/source/numerics/data_out_rotation.inst.in +++ b/source/numerics/data_out_rotation.inst.in @@ -17,6 +17,6 @@ for (deal_II_dimension : DIMENSIONS) { #if deal_II_dimension < 3 - template class DataOutRotation >; + template class DataOutRotation >; #endif } diff --git a/source/numerics/data_out_stack.inst.in b/source/numerics/data_out_stack.inst.in index b8e9f6d8c8..4de5ca173c 100644 --- a/source/numerics/data_out_stack.inst.in +++ b/source/numerics/data_out_stack.inst.in @@ -17,37 +17,37 @@ for (deal_II_dimension : DIMENSIONS) { #if deal_II_dimension < 3 -template class DataOutStack >; - -template void DataOutStack >:: -add_data_vector (const Vector &, - const std::string &); -template void DataOutStack >:: -add_data_vector (const Vector &, - const std::string &); - -template void DataOutStack >:: -add_data_vector (const Vector &, - const std::vector &); -template void DataOutStack >:: -add_data_vector (const Vector &, - const std::vector &); - - -template class DataOutStack >; - -template void DataOutStack >:: -add_data_vector (const Vector &, - const std::string &); -template void DataOutStack >:: -add_data_vector (const Vector &, - const std::string &); - -template void DataOutStack >:: -add_data_vector (const Vector &, - const std::vector &); -template void DataOutStack >:: -add_data_vector (const Vector &, - const std::vector &); + template class DataOutStack >; + + template void DataOutStack >:: + add_data_vector (const Vector &, + const std::string &); + template void DataOutStack >:: + add_data_vector (const Vector &, + const std::string &); + + template void DataOutStack >:: + add_data_vector (const Vector &, + const std::vector &); + template void DataOutStack >:: + add_data_vector (const Vector &, + const std::vector &); + + + template class DataOutStack >; + + template void DataOutStack >:: + add_data_vector (const Vector &, + const std::string &); + template void DataOutStack >:: + add_data_vector (const Vector &, + const std::string &); + + template void DataOutStack >:: + add_data_vector (const Vector &, + const std::vector &); + template void DataOutStack >:: + add_data_vector (const Vector &, + const std::vector &); #endif } diff --git a/source/numerics/data_postprocessor.inst.in b/source/numerics/data_postprocessor.inst.in index d2138659f2..49fbe4b268 100644 --- a/source/numerics/data_postprocessor.inst.in +++ b/source/numerics/data_postprocessor.inst.in @@ -16,7 +16,7 @@ for (deal_II_dimension : DIMENSIONS) { - template class DataPostprocessor; - template class DataPostprocessorScalar; - template class DataPostprocessorVector; + template class DataPostprocessor; + template class DataPostprocessorScalar; + template class DataPostprocessorVector; } diff --git a/source/numerics/derivative_approximation.inst.in b/source/numerics/derivative_approximation.inst.in index c1c1272060..e8d092705e 100644 --- a/source/numerics/derivative_approximation.inst.in +++ b/source/numerics/derivative_approximation.inst.in @@ -16,118 +16,118 @@ for (deal_II_dimension : DIMENSIONS ; VEC : REAL_SERIAL_VECTORS ; DH : DOFHANDLER_TEMPLATES) { - namespace DerivativeApproximation - \{ -template -void -approximate_gradient -(const Mapping &mapping, - const DH &dof_handler, - const VEC &solution, - Vector &derivative_norm, - const unsigned int component); - -template -void -approximate_gradient -(const DH &dof_handler, - const VEC &solution, - Vector &derivative_norm, - const unsigned int component); - -template -void -approximate_second_derivative -(const Mapping &mapping, - const DH &dof_handler, - const VEC &solution, - Vector &derivative_norm, - const unsigned int component); - -template -void -approximate_second_derivative -(const DH &dof_handler, - const VEC &solution, - Vector &derivative_norm, - const unsigned int component); - -template -void -approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 1 > -(const Mapping &mapping, - const DH &dof_handler, - const VEC &solution, - const DH ::active_cell_iterator &cell, - Tensor<1,deal_II_dimension> &derivative, - const unsigned int component); - -template -void -approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 2 > -(const Mapping &mapping, - const DH &dof_handler, - const VEC &solution, - const DH ::active_cell_iterator &cell, - Tensor<2,deal_II_dimension> &derivative, - const unsigned int component); - -template -void -approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 3 > -(const Mapping &mapping, - const DH &dof_handler, - const VEC &solution, - const DH ::active_cell_iterator &cell, - Tensor<3,deal_II_dimension> &derivative, - const unsigned int component); - - -template -void -approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 1 > -(const DH &dof_handler, - const VEC &solution, - const DH ::active_cell_iterator &cell, - Tensor<1,deal_II_dimension> &derivative, - const unsigned int component); - -template -void -approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 2 > -(const DH &dof_handler, - const VEC &solution, - const DH ::active_cell_iterator &cell, - Tensor<2,deal_II_dimension> &derivative, - const unsigned int component); - -template -void -approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 3 > -(const DH &dof_handler, - const VEC &solution, - const DH ::active_cell_iterator &cell, - Tensor<3,deal_II_dimension> &derivative, - const unsigned int component); - - \} + namespace DerivativeApproximation + \{ + template + void + approximate_gradient + (const Mapping &mapping, + const DH &dof_handler, + const VEC &solution, + Vector &derivative_norm, + const unsigned int component); + + template + void + approximate_gradient + (const DH &dof_handler, + const VEC &solution, + Vector &derivative_norm, + const unsigned int component); + + template + void + approximate_second_derivative + (const Mapping &mapping, + const DH &dof_handler, + const VEC &solution, + Vector &derivative_norm, + const unsigned int component); + + template + void + approximate_second_derivative + (const DH &dof_handler, + const VEC &solution, + Vector &derivative_norm, + const unsigned int component); + + template + void + approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 1 > + (const Mapping &mapping, + const DH &dof_handler, + const VEC &solution, + const DH ::active_cell_iterator &cell, + Tensor<1,deal_II_dimension> &derivative, + const unsigned int component); + + template + void + approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 2 > + (const Mapping &mapping, + const DH &dof_handler, + const VEC &solution, + const DH ::active_cell_iterator &cell, + Tensor<2,deal_II_dimension> &derivative, + const unsigned int component); + + template + void + approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 3 > + (const Mapping &mapping, + const DH &dof_handler, + const VEC &solution, + const DH ::active_cell_iterator &cell, + Tensor<3,deal_II_dimension> &derivative, + const unsigned int component); + + + template + void + approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 1 > + (const DH &dof_handler, + const VEC &solution, + const DH ::active_cell_iterator &cell, + Tensor<1,deal_II_dimension> &derivative, + const unsigned int component); + + template + void + approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 2 > + (const DH &dof_handler, + const VEC &solution, + const DH ::active_cell_iterator &cell, + Tensor<2,deal_II_dimension> &derivative, + const unsigned int component); + + template + void + approximate_derivative_tensor < DH , deal_II_dimension, deal_II_dimension, VEC, 3 > + (const DH &dof_handler, + const VEC &solution, + const DH ::active_cell_iterator &cell, + Tensor<3,deal_II_dimension> &derivative, + const unsigned int component); + + \} } for (deal_II_dimension : DIMENSIONS) { - namespace DerivativeApproximation - \{ -template -double -derivative_norm(const Tensor<1,deal_II_dimension> &derivative); - -template -double -derivative_norm(const Tensor<2,deal_II_dimension> &derivative); - -template -double -derivative_norm(const Tensor<3,deal_II_dimension> &derivative); - \} + namespace DerivativeApproximation + \{ + template + double + derivative_norm(const Tensor<1,deal_II_dimension> &derivative); + + template + double + derivative_norm(const Tensor<2,deal_II_dimension> &derivative); + + template + double + derivative_norm(const Tensor<3,deal_II_dimension> &derivative); + \} } diff --git a/source/numerics/dof_output_operator.inst.in b/source/numerics/dof_output_operator.inst.in index 75b65ed1e6..636a4dc730 100644 --- a/source/numerics/dof_output_operator.inst.in +++ b/source/numerics/dof_output_operator.inst.in @@ -16,5 +16,5 @@ for (VEC : REAL_SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS) { - template class DoFOutputOperator; + template class DoFOutputOperator; } diff --git a/source/numerics/error_estimator.inst.in b/source/numerics/error_estimator.inst.in index bdf76ecd9b..8524aeeaef 100644 --- a/source/numerics/error_estimator.inst.in +++ b/source/numerics/error_estimator.inst.in @@ -17,7 +17,7 @@ for (deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS) { #if deal_II_dimension != 1 && deal_II_dimension <= deal_II_space_dimension -template class KellyErrorEstimator; + template class KellyErrorEstimator; #endif } @@ -25,133 +25,133 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens { #if deal_II_dimension != 1 && deal_II_dimension <= deal_II_space_dimension -template -void -KellyErrorEstimator:: -estimate > (const Mapping &, - const DH &, - const Quadrature &, - const FunctionMap::type &, - const VEC &, - Vector &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id, - const KellyErrorEstimator::Strategy); + template + void + KellyErrorEstimator:: + estimate > (const Mapping &, + const DH &, + const Quadrature &, + const FunctionMap::type &, + const VEC &, + Vector &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id, + const KellyErrorEstimator::Strategy); -template -void -KellyErrorEstimator:: -estimate > ( - const DH &, - const Quadrature &, - const FunctionMap::type &, - const VEC &, - Vector &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id, - const KellyErrorEstimator::Strategy); + template + void + KellyErrorEstimator:: + estimate > ( + const DH &, + const Quadrature &, + const FunctionMap::type &, + const VEC &, + Vector &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id, + const KellyErrorEstimator::Strategy); -template -void -KellyErrorEstimator:: -estimate > (const Mapping &, - const DH &, - const Quadrature &, - const FunctionMap::type &, - const std::vector &, - std::vector *> &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id, - const KellyErrorEstimator::Strategy); + template + void + KellyErrorEstimator:: + estimate > (const Mapping &, + const DH &, + const Quadrature &, + const FunctionMap::type &, + const std::vector &, + std::vector *> &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id, + const KellyErrorEstimator::Strategy); -template -void -KellyErrorEstimator:: -estimate > ( - const DH &, - const Quadrature &, - const FunctionMap::type &, - const std::vector &, - std::vector *> &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id, - const KellyErrorEstimator::Strategy); + template + void + KellyErrorEstimator:: + estimate > ( + const DH &, + const Quadrature &, + const FunctionMap::type &, + const std::vector &, + std::vector *> &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id, + const KellyErrorEstimator::Strategy); -template -void -KellyErrorEstimator:: -estimate > (const Mapping &, - const DH &, - const hp::QCollection &, - const FunctionMap::type &, - const VEC &, - Vector &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id, - const KellyErrorEstimator::Strategy); + template + void + KellyErrorEstimator:: + estimate > (const Mapping &, + const DH &, + const hp::QCollection &, + const FunctionMap::type &, + const VEC &, + Vector &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id, + const KellyErrorEstimator::Strategy); -template -void -KellyErrorEstimator:: -estimate > ( - const DH &, - const hp::QCollection &, - const FunctionMap::type &, - const VEC &, - Vector &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id, - const KellyErrorEstimator::Strategy); + template + void + KellyErrorEstimator:: + estimate > ( + const DH &, + const hp::QCollection &, + const FunctionMap::type &, + const VEC &, + Vector &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id, + const KellyErrorEstimator::Strategy); -template -void -KellyErrorEstimator:: -estimate > (const Mapping &, - const DH &, - const hp::QCollection &, - const FunctionMap::type &, - const std::vector &, - std::vector *> &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id, - const KellyErrorEstimator::Strategy); + template + void + KellyErrorEstimator:: + estimate > (const Mapping &, + const DH &, + const hp::QCollection &, + const FunctionMap::type &, + const std::vector &, + std::vector *> &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id, + const KellyErrorEstimator::Strategy); -template -void -KellyErrorEstimator:: -estimate > ( - const DH &, - const hp::QCollection &, - const FunctionMap::type &, - const std::vector &, - std::vector *> &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id, - const KellyErrorEstimator::Strategy); + template + void + KellyErrorEstimator:: + estimate > ( + const DH &, + const hp::QCollection &, + const FunctionMap::type &, + const std::vector &, + std::vector *> &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id, + const KellyErrorEstimator::Strategy); #endif } diff --git a/source/numerics/error_estimator_1d.inst.in b/source/numerics/error_estimator_1d.inst.in index 5a54f2412d..66fc0420c3 100644 --- a/source/numerics/error_estimator_1d.inst.in +++ b/source/numerics/error_estimator_1d.inst.in @@ -18,125 +18,125 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens { #if deal_II_dimension == 1 && deal_II_dimension <= deal_II_space_dimension -template -void -KellyErrorEstimator:: -estimate > (const Mapping &, - const DH &, - const Quadrature &, - const FunctionMap::type &, - const VEC &, - Vector &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id); + template + void + KellyErrorEstimator:: + estimate > (const Mapping &, + const DH &, + const Quadrature &, + const FunctionMap::type &, + const VEC &, + Vector &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id); -template -void -KellyErrorEstimator:: -estimate > ( - const DH &, - const Quadrature &, - const FunctionMap::type &, - const VEC &, - Vector &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id); + template + void + KellyErrorEstimator:: + estimate > ( + const DH &, + const Quadrature &, + const FunctionMap::type &, + const VEC &, + Vector &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id); -template -void -KellyErrorEstimator:: -estimate > (const Mapping &, - const DH &, - const Quadrature &, - const FunctionMap::type &, - const std::vector &, - std::vector *> &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id); + template + void + KellyErrorEstimator:: + estimate > (const Mapping &, + const DH &, + const Quadrature &, + const FunctionMap::type &, + const std::vector &, + std::vector *> &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id); -template -void -KellyErrorEstimator:: -estimate > ( - const DH &, - const Quadrature &, - const FunctionMap::type &, - const std::vector &, - std::vector *> &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id); + template + void + KellyErrorEstimator:: + estimate > ( + const DH &, + const Quadrature &, + const FunctionMap::type &, + const std::vector &, + std::vector *> &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id); -template -void -KellyErrorEstimator:: -estimate > (const Mapping &, - const DH &, - const hp::QCollection &, - const FunctionMap::type &, - const VEC &, - Vector &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id); + template + void + KellyErrorEstimator:: + estimate > (const Mapping &, + const DH &, + const hp::QCollection &, + const FunctionMap::type &, + const VEC &, + Vector &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id); -template -void -KellyErrorEstimator:: -estimate > ( - const DH &, - const hp::QCollection &, - const FunctionMap::type &, - const VEC &, - Vector &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id); + template + void + KellyErrorEstimator:: + estimate > ( + const DH &, + const hp::QCollection &, + const FunctionMap::type &, + const VEC &, + Vector &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id); -template -void -KellyErrorEstimator:: -estimate > (const Mapping &, - const DH &, - const hp::QCollection &, - const FunctionMap::type &, - const std::vector &, - std::vector *> &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id); + template + void + KellyErrorEstimator:: + estimate > (const Mapping &, + const DH &, + const hp::QCollection &, + const FunctionMap::type &, + const std::vector &, + std::vector *> &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id); -template -void -KellyErrorEstimator:: -estimate > ( - const DH &, - const hp::QCollection &, - const FunctionMap::type &, - const std::vector &, - std::vector *> &, - const ComponentMask &, - const Function *, - const unsigned int , - const unsigned int , - const types::material_id); + template + void + KellyErrorEstimator:: + estimate > ( + const DH &, + const hp::QCollection &, + const FunctionMap::type &, + const std::vector &, + std::vector *> &, + const ComponentMask &, + const Function *, + const unsigned int , + const unsigned int , + const types::material_id); #endif } diff --git a/source/numerics/fe_field_function.inst.in b/source/numerics/fe_field_function.inst.in index 50660e2e4b..1f496c8a84 100644 --- a/source/numerics/fe_field_function.inst.in +++ b/source/numerics/fe_field_function.inst.in @@ -17,11 +17,11 @@ for (VECTOR : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS) { - template class FEFieldFunction, - VECTOR>; + template class FEFieldFunction, + VECTOR>; - template class FEFieldFunction, - VECTOR>; + template class FEFieldFunction, + VECTOR>; } diff --git a/source/numerics/matrix_creator.inst.in b/source/numerics/matrix_creator.inst.in index ca84d978bc..2542add90c 100644 --- a/source/numerics/matrix_creator.inst.in +++ b/source/numerics/matrix_creator.inst.in @@ -15,217 +15,217 @@ for (scalar: REAL_SCALARS; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension // non-hp version of create_mass_matrix template - void MatrixCreator::create_mass_matrix - (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_mass_matrix - (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_mass_matrix - (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_mass_matrix - (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_mass_matrix + (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_mass_matrix + (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_mass_matrix + (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_mass_matrix + (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); #endif - } +} for (scalar: COMPLEX_SCALARS; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension // non-hp version of create_mass_matrix template - void MatrixCreator::create_mass_matrix - (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_mass_matrix - (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_mass_matrix - (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_mass_matrix - (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_mass_matrix + (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_mass_matrix + (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_mass_matrix + (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_mass_matrix + (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); #endif - } +} for (scalar: REAL_SCALARS; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template - void MatrixCreator::create_boundary_mass_matrix - (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const std::map*> &rhs, - Vector &rhs_vector, - std::vector &dof_to_boundary_mapping, - const Function * const a, - std::vector); - - template - void MatrixCreator::create_boundary_mass_matrix - (const Mapping &, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const std::map*> &rhs, - Vector &rhs_vector, - std::vector &dof_to_boundary_mapping, - const Function * const a, - std::vector); - - template - void - MatrixCreator::create_boundary_mass_matrix - (const hp::MappingCollection&, - const hp::DoFHandler&, - const hp::QCollection&, - SparseMatrix&, - const std::map*>&, - Vector&, - std::vector&, - const Function * const, - std::vector); - - template - void MatrixCreator::create_boundary_mass_matrix - (const hp::DoFHandler&, - const hp::QCollection&, - SparseMatrix&, - const std::map*>&, - Vector&, - std::vector&, - const Function * const, - std::vector); + void MatrixCreator::create_boundary_mass_matrix + (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const std::map*> &rhs, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const a, + std::vector); + + template + void MatrixCreator::create_boundary_mass_matrix + (const Mapping &, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const std::map*> &rhs, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const a, + std::vector); + + template + void + MatrixCreator::create_boundary_mass_matrix + (const hp::MappingCollection&, + const hp::DoFHandler&, + const hp::QCollection&, + SparseMatrix&, + const std::map*>&, + Vector&, + std::vector&, + const Function * const, + std::vector); + + template + void MatrixCreator::create_boundary_mass_matrix + (const hp::DoFHandler&, + const hp::QCollection&, + SparseMatrix&, + const std::map*>&, + Vector&, + std::vector&, + const Function * const, + std::vector); #endif - } +} for (scalar: COMPLEX_SCALARS; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension template - void MatrixCreator::create_boundary_mass_matrix - (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const std::map*> &rhs, - Vector &rhs_vector, - std::vector &dof_to_boundary_mapping, - const Function * const a, - std::vector); - - template - void MatrixCreator::create_boundary_mass_matrix - (const Mapping &, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const std::map*> &rhs, - Vector &rhs_vector, - std::vector &dof_to_boundary_mapping, - const Function * const a, - std::vector); - - template - void - MatrixCreator::create_boundary_mass_matrix - (const hp::MappingCollection&, - const hp::DoFHandler&, - const hp::QCollection&, - SparseMatrix&, - const std::map*>&, - Vector&, - std::vector&, - const Function * const, - std::vector); - - template - void MatrixCreator::create_boundary_mass_matrix - (const hp::DoFHandler&, - const hp::QCollection&, - SparseMatrix&, - const std::map*>&, - Vector&, - std::vector&, - const Function * const, - std::vector); + void MatrixCreator::create_boundary_mass_matrix + (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const std::map*> &rhs, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const a, + std::vector); + + template + void MatrixCreator::create_boundary_mass_matrix + (const Mapping &, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const std::map*> &rhs, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const a, + std::vector); + + template + void + MatrixCreator::create_boundary_mass_matrix + (const hp::MappingCollection&, + const hp::DoFHandler&, + const hp::QCollection&, + SparseMatrix&, + const std::map*>&, + Vector&, + std::vector&, + const Function * const, + std::vector); + + template + void MatrixCreator::create_boundary_mass_matrix + (const hp::DoFHandler&, + const hp::QCollection&, + SparseMatrix&, + const std::map*>&, + Vector&, + std::vector&, + const Function * const, + std::vector); #endif - } +} //TODO[SP]: replace by // where applicable and move to codimension cases above also when applicable for (scalar : REAL_SCALARS; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ // hp versions of functions #if deal_II_dimension <= deal_II_space_dimension template - void MatrixCreator::create_mass_matrix - (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - - template - void MatrixCreator::create_mass_matrix - (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_mass_matrix + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + + template + void MatrixCreator::create_mass_matrix + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); #endif @@ -233,193 +233,193 @@ for (scalar : REAL_SCALARS; deal_II_dimension : DIMENSIONS; deal_II_space_dimens template - void MatrixCreator::create_mass_matrix - (const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_mass_matrix + (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); template - void MatrixCreator::create_mass_matrix - (const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_mass_matrix + (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); #endif - } +} for (scalar : COMPLEX_SCALARS; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ // hp versions of functions #if deal_II_dimension <= deal_II_space_dimension template - void MatrixCreator::create_mass_matrix - (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - - template - void MatrixCreator::create_mass_matrix - (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_mass_matrix + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + + template + void MatrixCreator::create_mass_matrix + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); #endif #if deal_II_dimension == deal_II_space_dimension - + template - void MatrixCreator::create_mass_matrix - (const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_mass_matrix + (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); template - void MatrixCreator::create_mass_matrix - (const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_mass_matrix + (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); #endif - } +} for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension == deal_II_space_dimension // non-hp versions of create_laplace_matrix template - void MatrixCreator::create_laplace_matrix - (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_laplace_matrix - (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_laplace_matrix - (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_laplace_matrix - (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_laplace_matrix + (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_laplace_matrix + (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_laplace_matrix + (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_laplace_matrix + (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); // hp versions of create_laplace_matrix template - void MatrixCreator::create_laplace_matrix - (const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_laplace_matrix - (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_laplace_matrix - (const hp::MappingCollection &mapping, - const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_laplace_matrix - (const hp::DoFHandler &dof, - const hp::QCollection &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_laplace_matrix + (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_laplace_matrix + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_laplace_matrix + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_laplace_matrix + (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); #endif - } +} for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension < deal_II_space_dimension // non-hp version of create_laplace_matrix template - void MatrixCreator::create_laplace_matrix - (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_laplace_matrix - (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_laplace_matrix - (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); - template - void MatrixCreator::create_laplace_matrix - (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function &rhs, - Vector &rhs_vector, - const Function * const coefficient, - const ConstraintMatrix &constraints); + void MatrixCreator::create_laplace_matrix + (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_laplace_matrix + (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_laplace_matrix + (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); + template + void MatrixCreator::create_laplace_matrix + (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const ConstraintMatrix &constraints); #endif - } +} diff --git a/source/numerics/matrix_tools.inst.in b/source/numerics/matrix_tools.inst.in index a257694a77..4f5e9d2409 100644 --- a/source/numerics/matrix_tools.inst.in +++ b/source/numerics/matrix_tools.inst.in @@ -14,41 +14,41 @@ // --------------------------------------------------------------------- for (number: REAL_SCALARS) - { +{ template - void MatrixTools::local_apply_boundary_values - (const std::map &boundary_values, - const std::vector &local_dof_indices, - FullMatrix &local_matrix, - Vector &local_rhs, - const bool eliminate_columns); + void MatrixTools::local_apply_boundary_values + (const std::map &boundary_values, + const std::vector &local_dof_indices, + FullMatrix &local_matrix, + Vector &local_rhs, + const bool eliminate_columns); template - void MatrixTools::apply_boundary_values - (const std::map &boundary_values, - SparseMatrix &matrix, - Vector &solution, - Vector &right_hand_side, - const bool eliminate_columns); + void MatrixTools::apply_boundary_values + (const std::map &boundary_values, + SparseMatrix &matrix, + Vector &solution, + Vector &right_hand_side, + const bool eliminate_columns); template - void MatrixTools::apply_boundary_values - (const std::map &boundary_values, - BlockSparseMatrix &matrix, - BlockVector &solution, - BlockVector &right_hand_side, - const bool eliminate_columns); + void MatrixTools::apply_boundary_values + (const std::map &boundary_values, + BlockSparseMatrix &matrix, + BlockVector &solution, + BlockVector &right_hand_side, + const bool eliminate_columns); - } +} for (number: COMPLEX_SCALARS) - { +{ template - void MatrixTools::apply_boundary_values - (const std::map &boundary_values, - SparseMatrix &matrix, - Vector &solution, - Vector &right_hand_side, - const bool eliminate_columns); - } + void MatrixTools::apply_boundary_values + (const std::map &boundary_values, + SparseMatrix &matrix, + Vector &solution, + Vector &right_hand_side, + const bool eliminate_columns); +} diff --git a/source/numerics/point_value_history.inst.in b/source/numerics/point_value_history.inst.in index d5e1b6783c..a16868b2c7 100644 --- a/source/numerics/point_value_history.inst.in +++ b/source/numerics/point_value_history.inst.in @@ -17,43 +17,43 @@ for (deal_II_dimension : DIMENSIONS) { - template class PointValueHistory; + template class PointValueHistory; } for (VEC : REAL_SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS) -{ - template - void PointValueHistory::evaluate_field - (const std::string &, - const VEC &); +{ + template + void PointValueHistory::evaluate_field + (const std::string &, + const VEC &); } for (VEC : REAL_SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS) -{ - template - void PointValueHistory::evaluate_field_at_requested_location - (const std::string &, - const VEC &); +{ + template + void PointValueHistory::evaluate_field_at_requested_location + (const std::string &, + const VEC &); } for (VEC : REAL_SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS) -{ - template - void PointValueHistory::evaluate_field - (const std::vector &, - const VEC &, - const DataPostprocessor &, - const Quadrature &); +{ + template + void PointValueHistory::evaluate_field + (const std::vector &, + const VEC &, + const DataPostprocessor &, + const Quadrature &); } for (VEC : REAL_SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS) -{ - template - void PointValueHistory::evaluate_field - (const std::string &, - const VEC &, - const DataPostprocessor &, - const Quadrature &); +{ + template + void PointValueHistory::evaluate_field + (const std::string &, + const VEC &, + const DataPostprocessor &, + const Quadrature &); } diff --git a/source/numerics/time_dependent.inst.in b/source/numerics/time_dependent.inst.in index fd494b2680..c284bdea00 100644 --- a/source/numerics/time_dependent.inst.in +++ b/source/numerics/time_dependent.inst.in @@ -16,11 +16,11 @@ for (deal_II_dimension : DIMENSIONS) { - template class TimeStepBase_Tria; - namespace TimeStepBase_Tria_Flags - \{ - template struct Flags; - template struct RefinementFlags; - template struct RefinementData; - \} + template class TimeStepBase_Tria; + namespace TimeStepBase_Tria_Flags + \{ + template struct Flags; + template struct RefinementFlags; + template struct RefinementData; + \} } diff --git a/source/numerics/vector_tools_boundary.inst.in b/source/numerics/vector_tools_boundary.inst.in index b5fef1b0e5..edb56654b7 100644 --- a/source/numerics/vector_tools_boundary.inst.in +++ b/source/numerics/vector_tools_boundary.inst.in @@ -15,173 +15,173 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; DH : DOFHANDLER_TEMPLATES) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace VectorTools \{ - template - void interpolate_boundary_values - (const Mapping &, - const DH &, - const std::map*> &, - std::map &, - const ComponentMask &); - - template - void interpolate_boundary_values - (const Mapping &, - const DH &, - const types::boundary_id, - const Function &, - std::map &, - const ComponentMask &); - - template - void interpolate_boundary_values ( - const DH &, - const types::boundary_id, - const Function &, - std::map &, - const ComponentMask &); - - template - void interpolate_boundary_values - (const DH &, - const std::map*> &, - std::map &, - const ComponentMask &); - - template - void interpolate_boundary_values ( - const Mapping &, - const DH &, - const std::map*> &, - ConstraintMatrix &, - const ComponentMask &); - - template - void interpolate_boundary_values - (const Mapping &, - const DH &, - const types::boundary_id, - const Function &, - ConstraintMatrix &, - const ComponentMask &); - - template - void interpolate_boundary_values ( - const DH &, - const types::boundary_id, - const Function &, - ConstraintMatrix &, - const ComponentMask &); - - template - void interpolate_boundary_values ( - const DH &, - const std::map*> &, - ConstraintMatrix &, - const ComponentMask &); - \} + template + void interpolate_boundary_values + (const Mapping &, + const DH &, + const std::map*> &, + std::map &, + const ComponentMask &); + + template + void interpolate_boundary_values + (const Mapping &, + const DH &, + const types::boundary_id, + const Function &, + std::map &, + const ComponentMask &); + + template + void interpolate_boundary_values ( + const DH &, + const types::boundary_id, + const Function &, + std::map &, + const ComponentMask &); + + template + void interpolate_boundary_values + (const DH &, + const std::map*> &, + std::map &, + const ComponentMask &); + + template + void interpolate_boundary_values ( + const Mapping &, + const DH &, + const std::map*> &, + ConstraintMatrix &, + const ComponentMask &); + + template + void interpolate_boundary_values + (const Mapping &, + const DH &, + const types::boundary_id, + const Function &, + ConstraintMatrix &, + const ComponentMask &); + + template + void interpolate_boundary_values ( + const DH &, + const types::boundary_id, + const Function &, + ConstraintMatrix &, + const ComponentMask &); + + template + void interpolate_boundary_values ( + const DH &, + const std::map*> &, + ConstraintMatrix &, + const ComponentMask &); + \} #endif } for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ namespace VectorTools \{ #if deal_II_dimension == deal_II_space_dimension - template - void project_boundary_values - (const Mapping &, - const DoFHandler &, - const std::map*> &, - const Quadrature&, - std::map&, std::vector); - - template - void project_boundary_values - (const DoFHandler &, - const std::map*> &, - const Quadrature&, - std::map&, - std::vector); - - template - void project_boundary_values - (const Mapping &, - const DoFHandler &, - const std::map*> &, - const Quadrature&, - ConstraintMatrix&, std::vector); - - template - void project_boundary_values - (const DoFHandler &, - const std::map*> &, - const Quadrature&, - ConstraintMatrix&, - std::vector); - - template - void project_boundary_values - (const hp::DoFHandler &, - const std::map*> &, - const hp::QCollection &, - std::map &, - std::vector); + template + void project_boundary_values + (const Mapping &, + const DoFHandler &, + const std::map*> &, + const Quadrature&, + std::map&, std::vector); + + template + void project_boundary_values + (const DoFHandler &, + const std::map*> &, + const Quadrature&, + std::map&, + std::vector); + + template + void project_boundary_values + (const Mapping &, + const DoFHandler &, + const std::map*> &, + const Quadrature&, + ConstraintMatrix&, std::vector); + + template + void project_boundary_values + (const DoFHandler &, + const std::map*> &, + const Quadrature&, + ConstraintMatrix&, + std::vector); + + template + void project_boundary_values + (const hp::DoFHandler &, + const std::map*> &, + const hp::QCollection &, + std::map &, + std::vector); #if deal_II_dimension != 1 - template - void project_boundary_values_curl_conforming - (const DoFHandler&, - const unsigned int, - const Function&, - const types::boundary_id, - ConstraintMatrix&, - const Mapping&); - template - void project_boundary_values_curl_conforming - (const hp::DoFHandler&, - const unsigned int, - const Function&, - const types::boundary_id, - ConstraintMatrix&, - const hp::MappingCollection&); - template - void project_boundary_values_curl_conforming_l2 - (const DoFHandler&, - const unsigned int, - const Function&, - const types::boundary_id, - ConstraintMatrix&, - const Mapping&); - template - void project_boundary_values_curl_conforming_l2 - (const hp::DoFHandler&, - const unsigned int, - const Function&, - const types::boundary_id, - ConstraintMatrix&, - const hp::MappingCollection&); - template - void project_boundary_values_div_conforming - (const DoFHandler&, - const unsigned int, - const Function&, - const types::boundary_id, - ConstraintMatrix&, - const Mapping&); - template - void project_boundary_values_div_conforming - (const hp::DoFHandler&, - const unsigned int, - const Function&, - const types::boundary_id, - ConstraintMatrix&, - const hp::MappingCollection&); + template + void project_boundary_values_curl_conforming + (const DoFHandler&, + const unsigned int, + const Function&, + const types::boundary_id, + ConstraintMatrix&, + const Mapping&); + template + void project_boundary_values_curl_conforming + (const hp::DoFHandler&, + const unsigned int, + const Function&, + const types::boundary_id, + ConstraintMatrix&, + const hp::MappingCollection&); + template + void project_boundary_values_curl_conforming_l2 + (const DoFHandler&, + const unsigned int, + const Function&, + const types::boundary_id, + ConstraintMatrix&, + const Mapping&); + template + void project_boundary_values_curl_conforming_l2 + (const hp::DoFHandler&, + const unsigned int, + const Function&, + const types::boundary_id, + ConstraintMatrix&, + const hp::MappingCollection&); + template + void project_boundary_values_div_conforming + (const DoFHandler&, + const unsigned int, + const Function&, + const types::boundary_id, + ConstraintMatrix&, + const Mapping&); + template + void project_boundary_values_div_conforming + (const hp::DoFHandler&, + const unsigned int, + const Function&, + const types::boundary_id, + ConstraintMatrix&, + const hp::MappingCollection&); #endif #endif - \} - } + \} +} diff --git a/source/numerics/vector_tools_constraints.inst.in b/source/numerics/vector_tools_constraints.inst.in index dfd4d2736d..0c9b81c317 100644 --- a/source/numerics/vector_tools_constraints.inst.in +++ b/source/numerics/vector_tools_constraints.inst.in @@ -18,77 +18,77 @@ // where applicable and move to codimension cases above also when applicable for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { - namespace VectorTools \{ + namespace VectorTools \{ #if deal_II_dimension == deal_II_space_dimension #if deal_II_dimension != 1 - template - void - compute_nonzero_normal_flux_constraints (const DoFHandler &dof_handler, - const unsigned int first_vector_component, - const std::set &boundary_ids, - FunctionMap::type &function_map, - ConstraintMatrix &constraints, - const Mapping &mapping); + template + void + compute_nonzero_normal_flux_constraints (const DoFHandler &dof_handler, + const unsigned int first_vector_component, + const std::set &boundary_ids, + FunctionMap::type &function_map, + ConstraintMatrix &constraints, + const Mapping &mapping); - template - void - compute_nonzero_normal_flux_constraints (const hp::DoFHandler &dof_handler, - const unsigned int first_vector_component, - const std::set &boundary_ids, - FunctionMap::type &function_map, - ConstraintMatrix &constraints, - const Mapping &mapping); + template + void + compute_nonzero_normal_flux_constraints (const hp::DoFHandler &dof_handler, + const unsigned int first_vector_component, + const std::set &boundary_ids, + FunctionMap::type &function_map, + ConstraintMatrix &constraints, + const Mapping &mapping); - template - void - compute_nonzero_tangential_flux_constraints (const DoFHandler &dof_handler, - const unsigned int first_vector_component, - const std::set &boundary_ids, - FunctionMap::type &function_map, - ConstraintMatrix &constraints, - const Mapping &mapping); - template - void - compute_nonzero_tangential_flux_constraints (const hp::DoFHandler &dof_handler, - const unsigned int first_vector_component, - const std::set &boundary_ids, - FunctionMap::type &function_map, - ConstraintMatrix &constraints, - const Mapping &mapping); - - template - void - compute_no_normal_flux_constraints (const DoFHandler &dof_handler, - const unsigned int first_vector_component, - const std::set &boundary_ids, - ConstraintMatrix &constraints, - const Mapping &mapping); + template + void + compute_nonzero_tangential_flux_constraints (const DoFHandler &dof_handler, + const unsigned int first_vector_component, + const std::set &boundary_ids, + FunctionMap::type &function_map, + ConstraintMatrix &constraints, + const Mapping &mapping); + template + void + compute_nonzero_tangential_flux_constraints (const hp::DoFHandler &dof_handler, + const unsigned int first_vector_component, + const std::set &boundary_ids, + FunctionMap::type &function_map, + ConstraintMatrix &constraints, + const Mapping &mapping); - template - void - compute_no_normal_flux_constraints (const hp::DoFHandler &dof_handler, - const unsigned int first_vector_component, - const std::set &boundary_ids, - ConstraintMatrix &constraints, - const Mapping &mapping); - - template - void - compute_normal_flux_constraints (const DoFHandler &dof_handler, - const unsigned int first_vector_component, - const std::set &boundary_ids, - ConstraintMatrix &constraints, - const Mapping &mapping); + template + void + compute_no_normal_flux_constraints (const DoFHandler &dof_handler, + const unsigned int first_vector_component, + const std::set &boundary_ids, + ConstraintMatrix &constraints, + const Mapping &mapping); - template - void - compute_normal_flux_constraints (const hp::DoFHandler &dof_handler, - const unsigned int first_vector_component, - const std::set &boundary_ids, - ConstraintMatrix &constraints, - const Mapping &mapping); + template + void + compute_no_normal_flux_constraints (const hp::DoFHandler &dof_handler, + const unsigned int first_vector_component, + const std::set &boundary_ids, + ConstraintMatrix &constraints, + const Mapping &mapping); + + template + void + compute_normal_flux_constraints (const DoFHandler &dof_handler, + const unsigned int first_vector_component, + const std::set &boundary_ids, + ConstraintMatrix &constraints, + const Mapping &mapping); + + template + void + compute_normal_flux_constraints (const hp::DoFHandler &dof_handler, + const unsigned int first_vector_component, + const std::set &boundary_ids, + ConstraintMatrix &constraints, + const Mapping &mapping); #endif #endif - \} + \} } \ No newline at end of file diff --git a/source/numerics/vector_tools_integrate_difference.inst.in b/source/numerics/vector_tools_integrate_difference.inst.in index 7783007063..ab7b88333b 100644 --- a/source/numerics/vector_tools_integrate_difference.inst.in +++ b/source/numerics/vector_tools_integrate_difference.inst.in @@ -15,123 +15,123 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace VectorTools \{ - template - void integrate_difference, deal_II_space_dimension> - (const Mapping&, - const DoFHandler&, - const VEC&, - const Function&, - Vector&, - const Quadrature&, - const NormType&, - const Function*, - const double); + template + void integrate_difference, deal_II_space_dimension> + (const Mapping&, + const DoFHandler&, + const VEC&, + const Function&, + Vector&, + const Quadrature&, + const NormType&, + const Function*, + const double); - template - void integrate_difference, deal_II_space_dimension> - (const DoFHandler&, - const VEC&, - const Function&, - Vector&, - const Quadrature&, - const NormType&, - const Function*, - const double); + template + void integrate_difference, deal_II_space_dimension> + (const DoFHandler&, + const VEC&, + const Function&, + Vector&, + const Quadrature&, + const NormType&, + const Function*, + const double); - template - void integrate_difference, deal_II_space_dimension > - (const Mapping&, - const DoFHandler&, - const VEC&, - const Function&, - Vector&, - const Quadrature&, - const NormType&, - const Function*, - const double); + template + void integrate_difference, deal_II_space_dimension > + (const Mapping&, + const DoFHandler&, + const VEC&, + const Function&, + Vector&, + const Quadrature&, + const NormType&, + const Function*, + const double); - template - void integrate_difference, deal_II_space_dimension > - (const DoFHandler&, - const VEC&, - const Function&, - Vector&, - const Quadrature&, - const NormType&, - const Function*, - const double); + template + void integrate_difference, deal_II_space_dimension > + (const DoFHandler&, + const VEC&, + const Function&, + Vector&, + const Quadrature&, + const NormType&, + const Function*, + const double); - template - void integrate_difference, deal_II_space_dimension> - (const hp::MappingCollection&, - const hp::DoFHandler&, - const VEC&, - const Function&, - Vector&, - const hp::QCollection&, - const NormType&, - const Function*, - const double); + template + void integrate_difference, deal_II_space_dimension> + (const hp::MappingCollection&, + const hp::DoFHandler&, + const VEC&, + const Function&, + Vector&, + const hp::QCollection&, + const NormType&, + const Function*, + const double); - template - void integrate_difference, deal_II_space_dimension> - (const hp::DoFHandler&, - const VEC&, - const Function&, - Vector&, - const hp::QCollection&, - const NormType&, - const Function*, - const double); + template + void integrate_difference, deal_II_space_dimension> + (const hp::DoFHandler&, + const VEC&, + const Function&, + Vector&, + const hp::QCollection&, + const NormType&, + const Function*, + const double); - template - void integrate_difference, deal_II_space_dimension> - (const hp::MappingCollection&, - const hp::DoFHandler&, - const VEC&, - const Function&, - Vector&, - const hp::QCollection&, - const NormType&, - const Function*, - const double); + template + void integrate_difference, deal_II_space_dimension> + (const hp::MappingCollection&, + const hp::DoFHandler&, + const VEC&, + const Function&, + Vector&, + const hp::QCollection&, + const NormType&, + const Function*, + const double); - template - void integrate_difference, deal_II_space_dimension> - (const hp::DoFHandler&, - const VEC&, - const Function&, - Vector&, - const hp::QCollection&, - const NormType&, - const Function*, - const double); + template + void integrate_difference, deal_II_space_dimension> + (const hp::DoFHandler&, + const VEC&, + const Function&, + Vector&, + const hp::QCollection&, + const NormType&, + const Function*, + const double); - \} + \} #endif - } +} for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension - namespace VectorTools \{ - template + namespace VectorTools \{ + template double compute_global_error >( - const Triangulation &, + const Triangulation &, const Vector &, const NormType &, const double); - template + template double compute_global_error >( - const Triangulation &, + const Triangulation &, const Vector &, const NormType &, const double); - \} + \} #endif - } +} diff --git a/source/numerics/vector_tools_interpolate.inst.in b/source/numerics/vector_tools_interpolate.inst.in index da50372b88..621599b7cb 100644 --- a/source/numerics/vector_tools_interpolate.inst.in +++ b/source/numerics/vector_tools_interpolate.inst.in @@ -15,98 +15,98 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace VectorTools \{ - template - void interpolate - (const Mapping &, - const DoFHandler&, - const Function&, - VEC&, - const ComponentMask&); - - template - void interpolate - (const DoFHandler&, - const Function&, - VEC&, - const ComponentMask&); - - template - void interpolate - (const DoFHandler&, - const DoFHandler&, - const FullMatrix&, - const VEC&, - VEC&); - - template - void get_position_vector - (const DoFHandler&, - VEC&, - const ComponentMask&); - - \} + template + void interpolate + (const Mapping &, + const DoFHandler&, + const Function&, + VEC&, + const ComponentMask&); + + template + void interpolate + (const DoFHandler&, + const Function&, + VEC&, + const ComponentMask&); + + template + void interpolate + (const DoFHandler&, + const DoFHandler&, + const FullMatrix&, + const VEC&, + VEC&); + + template + void get_position_vector + (const DoFHandler&, + VEC&, + const ComponentMask&); + + \} #endif - } +} //TODO[SP]: replace by // where applicable and move to codimension cases above also when applicable for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension == deal_II_space_dimension namespace VectorTools \{ - template - void interpolate - (const Mapping&, - const hp::DoFHandler&, - const Function&, - VEC&, - const ComponentMask&); - template - void interpolate - (const hp::DoFHandler&, - const Function&, - VEC&, - const ComponentMask&); - - template - void interpolate_based_on_material_id(const Mapping&, - const DoFHandler&, - const std::map< types::material_id, const Function* >&, - VEC&, - const ComponentMask&); - - template - void interpolate_based_on_material_id(const Mapping&, - const hp::DoFHandler&, - const std::map< types::material_id, const Function* >&, - VEC&, - const ComponentMask&); - - \} + template + void interpolate + (const Mapping&, + const hp::DoFHandler&, + const Function&, + VEC&, + const ComponentMask&); + template + void interpolate + (const hp::DoFHandler&, + const Function&, + VEC&, + const ComponentMask&); + + template + void interpolate_based_on_material_id(const Mapping&, + const DoFHandler&, + const std::map< types::material_id, const Function* >&, + VEC&, + const ComponentMask&); + + template + void interpolate_based_on_material_id(const Mapping&, + const hp::DoFHandler&, + const std::map< types::material_id, const Function* >&, + VEC&, + const ComponentMask&); + + \} #endif - } +} - for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { - #if deal_II_dimension <= deal_II_space_dimension - namespace VectorTools \{ - template +for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) +{ +#if deal_II_dimension <= deal_II_space_dimension + namespace VectorTools \{ + template void interpolate_to_different_mesh (const DoFHandler &, const VEC &, const DoFHandler &, VEC &); - template + template void interpolate_to_different_mesh (const DoFHandler &, const VEC &, @@ -114,13 +114,13 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimens const ConstraintMatrix &, VEC &); - template + template void interpolate_to_different_mesh (const InterGridMap > &, const VEC &, const ConstraintMatrix &, VEC &); - \} - #endif + \} +#endif } diff --git a/source/numerics/vector_tools_mean_value.inst.in b/source/numerics/vector_tools_mean_value.inst.in index 06d304eb70..9f24e1cd76 100644 --- a/source/numerics/vector_tools_mean_value.inst.in +++ b/source/numerics/vector_tools_mean_value.inst.in @@ -15,35 +15,35 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace VectorTools \{ - template - VEC::value_type compute_mean_value - (const Mapping&, - const DoFHandler&, - const Quadrature&, - const VEC&, - const unsigned int); - - template - VEC::value_type compute_mean_value - (const DoFHandler&, - const Quadrature&, - const VEC&, - const unsigned int); - - \} + template + VEC::value_type compute_mean_value + (const Mapping&, + const DoFHandler&, + const Quadrature&, + const VEC&, + const unsigned int); + + template + VEC::value_type compute_mean_value + (const DoFHandler&, + const Quadrature&, + const VEC&, + const unsigned int); + + \} #endif - } +} for (VEC : SERIAL_VECTORS) { namespace VectorTools \{ - template - void subtract_mean_value(VEC &, const std::vector &); + template + void subtract_mean_value(VEC &, const std::vector &); \} } diff --git a/source/numerics/vector_tools_point_gradient.inst.in b/source/numerics/vector_tools_point_gradient.inst.in index ad02adcba7..bb7481132c 100644 --- a/source/numerics/vector_tools_point_gradient.inst.in +++ b/source/numerics/vector_tools_point_gradient.inst.in @@ -14,67 +14,67 @@ // --------------------------------------------------------------------- for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension == deal_II_space_dimension namespace VectorTools \{ - template + template void point_gradient ( - const hp::DoFHandler&, - const VEC&, - const Point&, - std::vector >&); + const hp::DoFHandler&, + const VEC&, + const Point&, + std::vector >&); - template + template Tensor<1,deal_II_space_dimension,VEC::value_type> point_gradient ( - const hp::DoFHandler&, - const VEC&, - const Point&); + const hp::DoFHandler&, + const VEC&, + const Point&); - template - void point_gradient ( - const hp::MappingCollection&, - const hp::DoFHandler&, - const VEC&, - const Point&, - std::vector >&); + template + void point_gradient ( + const hp::MappingCollection&, + const hp::DoFHandler&, + const VEC&, + const Point&, + std::vector >&); - template + template Tensor<1,deal_II_space_dimension,VEC::value_type> point_gradient ( - const hp::MappingCollection&, - const hp::DoFHandler&, - const VEC&, - const Point&); + const hp::MappingCollection&, + const hp::DoFHandler&, + const VEC&, + const Point&); - template + template void point_gradient ( - const DoFHandler&, - const VEC&, - const Point&, - std::vector >&); + const DoFHandler&, + const VEC&, + const Point&, + std::vector >&); - template + template Tensor<1,deal_II_space_dimension,VEC::value_type> point_gradient ( - const DoFHandler&, - const VEC&, - const Point&); + const DoFHandler&, + const VEC&, + const Point&); - template + template void point_gradient ( - const Mapping&, - const DoFHandler&, - const VEC&, - const Point&, - std::vector >&); + const Mapping&, + const DoFHandler&, + const VEC&, + const Point&, + std::vector >&); - template + template Tensor<1,deal_II_space_dimension,VEC::value_type> point_gradient ( - const Mapping&, - const DoFHandler&, - const VEC&, - const Point&); + const Mapping&, + const DoFHandler&, + const VEC&, + const Point&); - \} + \} #endif - } +} diff --git a/source/numerics/vector_tools_point_value.inst.in b/source/numerics/vector_tools_point_value.inst.in index 4c77fab747..e78a4b0288 100644 --- a/source/numerics/vector_tools_point_value.inst.in +++ b/source/numerics/vector_tools_point_value.inst.in @@ -17,148 +17,148 @@ //TODO[SP]: replace by // where applicable and move to codimension cases above also when applicable for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension == deal_II_space_dimension namespace VectorTools \{ - template + template void point_value ( - const hp::DoFHandler&, - const VEC&, - const Point&, - Vector&); + const hp::DoFHandler&, + const VEC&, + const Point&, + Vector&); - template + template VEC::value_type point_value ( - const hp::DoFHandler&, - const VEC&, - const Point&); + const hp::DoFHandler&, + const VEC&, + const Point&); - template + template void point_value ( - const hp::MappingCollection&, - const hp::DoFHandler&, - const VEC&, - const Point&, - Vector&); + const hp::MappingCollection&, + const hp::DoFHandler&, + const VEC&, + const Point&, + Vector&); - template + template VEC::value_type point_value ( - const hp::MappingCollection&, - const hp::DoFHandler&, - const VEC&, - const Point&); - - template - void point_difference ( - const DoFHandler&, - const VEC&, - const Function&, - Vector&, - const Point&); - - template - void point_difference ( - const Mapping&, - const DoFHandler&, - const VEC&, - const Function&, - Vector&, - const Point&); - - template - void point_value ( - const DoFHandler&, - const VEC&, - const Point&, - Vector&); - - template - VEC::value_type point_value ( - const DoFHandler&, - const VEC&, - const Point&); - - template - void point_value ( - const Mapping&, - const DoFHandler&, - const VEC&, - const Point&, - Vector&); - - template - VEC::value_type point_value ( - const Mapping&, - const DoFHandler&, - const VEC&, - const Point&); - - \} + const hp::MappingCollection&, + const hp::DoFHandler&, + const VEC&, + const Point&); + + template + void point_difference ( + const DoFHandler&, + const VEC&, + const Function&, + Vector&, + const Point&); + + template + void point_difference ( + const Mapping&, + const DoFHandler&, + const VEC&, + const Function&, + Vector&, + const Point&); + + template + void point_value ( + const DoFHandler&, + const VEC&, + const Point&, + Vector&); + + template + VEC::value_type point_value ( + const DoFHandler&, + const VEC&, + const Point&); + + template + void point_value ( + const Mapping&, + const DoFHandler&, + const VEC&, + const Point&, + Vector&); + + template + VEC::value_type point_value ( + const Mapping&, + const DoFHandler&, + const VEC&, + const Point&); + + \} #endif - } +} //TODO[SP]: replace by // where applicable and move to codimension cases above also when applicable for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ namespace VectorTools \{ #if deal_II_dimension == deal_II_space_dimension - template - void create_point_source_vector - (const Mapping &, - const DoFHandler &, - const Point &, - Vector &); - template - void create_point_source_vector - (const DoFHandler &, - const Point &, - Vector &); - - template - void create_point_source_vector - (const hp::MappingCollection &, - const hp::DoFHandler &, - const Point &, - Vector &); - template - void create_point_source_vector - (const hp::DoFHandler &, - const Point &, - Vector &); - template - void create_point_source_vector - (const Mapping &, - const DoFHandler &, - const Point &, - const Point &, - Vector &); - template - void create_point_source_vector - (const DoFHandler &, - const Point &, - const Point &, - Vector &); - - template - void create_point_source_vector - (const hp::MappingCollection &, - const hp::DoFHandler &, - const Point &, - const Point &, - Vector &); - template - void create_point_source_vector - (const hp::DoFHandler &, - const Point &, - const Point &, - Vector &); + template + void create_point_source_vector + (const Mapping &, + const DoFHandler &, + const Point &, + Vector &); + template + void create_point_source_vector + (const DoFHandler &, + const Point &, + Vector &); + + template + void create_point_source_vector + (const hp::MappingCollection &, + const hp::DoFHandler &, + const Point &, + Vector &); + template + void create_point_source_vector + (const hp::DoFHandler &, + const Point &, + Vector &); + template + void create_point_source_vector + (const Mapping &, + const DoFHandler &, + const Point &, + const Point &, + Vector &); + template + void create_point_source_vector + (const DoFHandler &, + const Point &, + const Point &, + Vector &); + + template + void create_point_source_vector + (const hp::MappingCollection &, + const hp::DoFHandler &, + const Point &, + const Point &, + Vector &); + template + void create_point_source_vector + (const hp::DoFHandler &, + const Point &, + const Point &, + Vector &); #endif - \} - } + \} +} diff --git a/source/numerics/vector_tools_project.inst.in b/source/numerics/vector_tools_project.inst.in index ffbdda0908..27e1397b54 100644 --- a/source/numerics/vector_tools_project.inst.in +++ b/source/numerics/vector_tools_project.inst.in @@ -15,55 +15,55 @@ for (VEC : SERIAL_VECTORS ; deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace VectorTools \{ - template - void project - (const Mapping &, - const DoFHandler &, - const ConstraintMatrix &, - const Quadrature &, - const Function &, - VEC &, - const bool, - const Quadrature &, - const bool); + template + void project + (const Mapping &, + const DoFHandler &, + const ConstraintMatrix &, + const Quadrature &, + const Function &, + VEC &, + const bool, + const Quadrature &, + const bool); - template - void project - (const DoFHandler &, - const ConstraintMatrix &, - const Quadrature &, - const Function &, - VEC &, - const bool, - const Quadrature &, - const bool); + template + void project + (const DoFHandler &, + const ConstraintMatrix &, + const Quadrature &, + const Function &, + VEC &, + const bool, + const Quadrature &, + const bool); - template - void project - (const hp::MappingCollection &, - const hp::DoFHandler &, - const ConstraintMatrix &, - const hp::QCollection &, - const Function &, - VEC &, - const bool, - const hp::QCollection &, - const bool); + template + void project + (const hp::MappingCollection &, + const hp::DoFHandler &, + const ConstraintMatrix &, + const hp::QCollection &, + const Function &, + VEC &, + const bool, + const hp::QCollection &, + const bool); - template - void project - (const hp::DoFHandler &, - const ConstraintMatrix &, - const hp::QCollection &, - const Function &, - VEC &, - const bool, - const hp::QCollection &, - const bool); - \} + template + void project + (const hp::DoFHandler &, + const ConstraintMatrix &, + const hp::QCollection &, + const Function &, + VEC &, + const bool, + const hp::QCollection &, + const bool); + \} #endif - } +} diff --git a/source/numerics/vector_tools_rhs.inst.in b/source/numerics/vector_tools_rhs.inst.in index b6fd287831..2c38f5a6d2 100644 --- a/source/numerics/vector_tools_rhs.inst.in +++ b/source/numerics/vector_tools_rhs.inst.in @@ -15,93 +15,93 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ #if deal_II_dimension <= deal_II_space_dimension namespace VectorTools \{ - template - void create_right_hand_side - (const Mapping &, - const DoFHandler &, - const Quadrature &, - const Function &, - Vector &); + template + void create_right_hand_side + (const Mapping &, + const DoFHandler &, + const Quadrature &, + const Function &, + Vector &); - template - void create_right_hand_side - (const DoFHandler &, - const Quadrature &, - const Function &, - Vector &); + template + void create_right_hand_side + (const DoFHandler &, + const Quadrature &, + const Function &, + Vector &); - \} + \} #endif - } +} //TODO[SP]: replace by // where applicable and move to codimension cases above also when applicable for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) - { +{ namespace VectorTools \{ #if deal_II_dimension == deal_II_space_dimension - template - void create_right_hand_side - (const hp::MappingCollection &, - const hp::DoFHandler &, - const hp::QCollection &, - const Function &, - Vector &); + template + void create_right_hand_side + (const hp::MappingCollection &, + const hp::DoFHandler &, + const hp::QCollection &, + const Function &, + Vector &); - template - void create_right_hand_side - (const hp::DoFHandler &, - const hp::QCollection &, - const Function &, - Vector &); + template + void create_right_hand_side + (const hp::DoFHandler &, + const hp::QCollection &, + const Function &, + Vector &); #if deal_II_dimension > 1 - template - void - create_boundary_right_hand_side - (const Mapping &, - const DoFHandler &, - const Quadrature &, - const Function &, - Vector &, - const std::set &); + template + void + create_boundary_right_hand_side + (const Mapping &, + const DoFHandler &, + const Quadrature &, + const Function &, + Vector &, + const std::set &); #endif - template - void - create_boundary_right_hand_side - (const DoFHandler &, - const Quadrature &, - const Function &, - Vector &, - const std::set &); + template + void + create_boundary_right_hand_side + (const DoFHandler &, + const Quadrature &, + const Function &, + Vector &, + const std::set &); #if deal_II_dimension > 1 - template - void - create_boundary_right_hand_side - (const hp::MappingCollection &, - const hp::DoFHandler &, - const hp::QCollection &, - const Function &, - Vector &, - const std::set &); + template + void + create_boundary_right_hand_side + (const hp::MappingCollection &, + const hp::DoFHandler &, + const hp::QCollection &, + const Function &, + Vector &, + const std::set &); #endif - template - void - create_boundary_right_hand_side - (const hp::DoFHandler &, - const hp::QCollection &, - const Function &, - Vector &, - const std::set &); + template + void + create_boundary_right_hand_side + (const hp::DoFHandler &, + const hp::QCollection &, + const Function &, + Vector &, + const std::set &); #endif - \} - } + \} +} diff --git a/source/opencascade/boundary_lib.inst.in b/source/opencascade/boundary_lib.inst.in index 1d7b4c891c..a43f51b688 100644 --- a/source/opencascade/boundary_lib.inst.in +++ b/source/opencascade/boundary_lib.inst.in @@ -16,12 +16,12 @@ for (deal_II_dimension : DIMENSIONS) - { - template class NormalProjectionBoundary; - template class DirectionalProjectionBoundary; - template class NormalToMeshProjectionBoundary; - template class ArclengthProjectionLineManifold; - } +{ + template class NormalProjectionBoundary; + template class DirectionalProjectionBoundary; + template class NormalToMeshProjectionBoundary; + template class ArclengthProjectionLineManifold; +} -- 2.39.5