diff --git a/README b/README index 93d0b6fa568059c5e363bcf239839d7fc76e658c..a5b072b8f8f293f42285cb710897293fa8187f03 100644 --- a/README +++ b/README @@ -18,11 +18,11 @@ using the main DUNE discretization modules, like dune-fem dune-pdelab (http://www.dune-project.org/pdelab/). New users may best try out this module by using the git supermodule -dune-gdt-demos (http://users.dune-project.org/projects/dune-gdt-demos). -Experienced DUNE users may go ahead. As usual, you will have to call autogen, +dune-gdt-super (https://github.com/dune-community/dune-gdt-super). +Experienced DUNE users may go ahead. As usual, you will have to call configure and make using dunecontrol (see http://www.dune-project.org/doc/installation-notes.html), working -examples are located in 'tests/'... +examples are located in 'dune/gdt/test/'... If you want to start hacking go ahead and fork us on github.com: -https://github.com/pymor/dune-gdt/ +https://github.com/dune-community/dune-gdt/ diff --git a/dune/gdt/assembler/system.hh b/dune/gdt/assembler/system.hh index daf1f26b74667260c442a7d6ec8f3d6254317b88..4a809838b44a82c2df522392402d547083abc11a 100644 --- a/dune/gdt/assembler/system.hh +++ b/dune/gdt/assembler/system.hh @@ -29,7 +29,7 @@ namespace GDT { template <class TestSpaceImp, class GridViewImp = typename TestSpaceImp::GridViewType, - class AnsatzSpaceImp = TestSpaceImp> + class AnsatzSpaceImp = TestSpaceImp> class SystemAssembler : public DSG::Walker<GridViewImp> { static_assert(GDT::is_space<TestSpaceImp>::value, "TestSpaceImp has to be derived from SpaceInterface!"); @@ -110,7 +110,8 @@ public: assert(matrix.cols() == ansatz_space_->mapper().size()); typedef internal::LocalVolumeTwoFormMatrixAssemblerWrapper<ThisType, LocalVolumeTwoFormAssembler<V>, - typename M::derived_type> WrapperType; + typename M::derived_type> + WrapperType; this->codim0_functors_.emplace_back( new WrapperType(test_space_, ansatz_space_, where, local_assembler, matrix.as_imp())); } // ... add(...) @@ -124,7 +125,8 @@ public: assert(matrix.cols() == ansatz_space_->mapper().size()); typedef internal::LocalCouplingTwoFormMatrixAssemblerWrapper<ThisType, LocalCouplingTwoFormAssembler<V>, - typename M::derived_type> WrapperType; + typename M::derived_type> + WrapperType; this->codim1_functors_.emplace_back( new WrapperType(test_space_, ansatz_space_, where, local_assembler, matrix.as_imp())); } // ... add(...) @@ -138,7 +140,8 @@ public: assert(matrix.cols() == ansatz_space_->mapper().size()); typedef internal::LocalBoundaryTwoFormMatrixAssemblerWrapper<ThisType, LocalBoundaryTwoFormAssembler<V>, - typename M::derived_type> WrapperType; + typename M::derived_type> + WrapperType; this->codim1_functors_.emplace_back( new WrapperType(test_space_, ansatz_space_, where, local_assembler, matrix.as_imp())); } // ... add(...) @@ -151,7 +154,8 @@ public: assert(vector.size() == test_space_->mapper().size()); typedef internal::LocalVolumeFunctionalVectorAssemblerWrapper<ThisType, LocalVolumeFunctionalAssembler<L>, - typename V::derived_type> WrapperType; + typename V::derived_type> + WrapperType; this->codim0_functors_.emplace_back(new WrapperType(test_space_, where, local_assembler, vector.as_imp())); } // ... add(...) @@ -163,7 +167,8 @@ public: assert(vector.size() == test_space_->mapper().size()); typedef internal::LocalFaceFunctionalVectorAssemblerWrapper<ThisType, LocalFaceFunctionalAssembler<L>, - typename V::derived_type> WrapperType; + typename V::derived_type> + WrapperType; this->codim1_functors_.emplace_back(new WrapperType(test_space_, where, local_assembler, vector.as_imp())); } // ... add(...) diff --git a/dune/gdt/assembler/wrapper.hh b/dune/gdt/assembler/wrapper.hh index 19448832665284df46e70f48b1cd4868a7e72c49..5eb3230a55c36b870af6dc543d26400634d29bc5 100644 --- a/dune/gdt/assembler/wrapper.hh +++ b/dune/gdt/assembler/wrapper.hh @@ -155,7 +155,8 @@ class LocalVolumeTwoFormWrapper { typedef DSC::ConstStorageProvider<LocalVolumeTwoFormAssembler<LocalVolumeTwoFormType>> LocalAssemblerProvider; typedef LocalVolumeTwoFormMatrixAssemblerWrapper<AssemblerType, LocalVolumeTwoFormAssembler<LocalVolumeTwoFormType>, - MatrixType> BaseType; + MatrixType> + BaseType; public: typedef typename AssemblerType::TestSpaceType TestSpaceType; @@ -238,7 +239,8 @@ class LocalCouplingTwoFormWrapper typedef DSC::ConstStorageProvider<LocalCouplingTwoFormAssembler<LocalCouplingTwoFormType>> LocalAssemblerProvider; typedef LocalCouplingTwoFormMatrixAssemblerWrapper<AssemblerType, LocalCouplingTwoFormAssembler<LocalCouplingTwoFormType>, - MatrixType> BaseType; + MatrixType> + BaseType; public: typedef typename AssemblerType::TestSpaceType TestSpaceType; @@ -321,7 +323,8 @@ class LocalBoundaryTwoFormWrapper typedef DSC::ConstStorageProvider<LocalBoundaryTwoFormAssembler<LocalBoundaryTwoFormType>> LocalAssemblerProvider; typedef LocalBoundaryTwoFormMatrixAssemblerWrapper<AssemblerType, LocalBoundaryTwoFormAssembler<LocalBoundaryTwoFormType>, - MatrixType> BaseType; + MatrixType> + BaseType; public: typedef typename AssemblerType::TestSpaceType TestSpaceType; @@ -398,8 +401,8 @@ class LocalVolumeFunctionalWrapper { typedef DSC::ConstStorageProvider<LocalVolumeFunctionalAssembler<LocalFunctionalType>> LocalAssemblerProvider; typedef LocalVolumeFunctionalVectorAssemblerWrapper<AssemblerType, - LocalVolumeFunctionalAssembler<LocalFunctionalType>, - VectorType> BaseType; + LocalVolumeFunctionalAssembler<LocalFunctionalType>, VectorType> + BaseType; public: typedef typename AssemblerType::TestSpaceType TestSpaceType; @@ -475,8 +478,8 @@ class LocalFaceFunctionalWrapper { typedef DSC::ConstStorageProvider<LocalFaceFunctionalAssembler<LocalFaceFunctionalType>> LocalAssemblerProvider; typedef LocalFaceFunctionalVectorAssemblerWrapper<AssemblerType, - LocalFaceFunctionalAssembler<LocalFaceFunctionalType>, - VectorType> BaseType; + LocalFaceFunctionalAssembler<LocalFaceFunctionalType>, VectorType> + BaseType; public: typedef typename AssemblerType::TestSpaceType TestSpaceType; diff --git a/dune/gdt/discretefunction/default.hh b/dune/gdt/discretefunction/default.hh index e1c53dad1ebf3f7febd31bb9b7530eab2ceb5779..0913bfaf43e5913b988882170459e932a5f9532c 100644 --- a/dune/gdt/discretefunction/default.hh +++ b/dune/gdt/discretefunction/default.hh @@ -78,7 +78,8 @@ struct visualize_helper<ii, true> } ConstDiscreteFunction< typename std::tuple_element<ii, typename DiscreteFunctionType::SpaceType::SpaceTupleType>::type, - typename DiscreteFunctionType::VectorType> factor_discrete_function(factor_space, factor_vector); + typename DiscreteFunctionType::VectorType> + factor_discrete_function(factor_space, factor_vector); factor_discrete_function.visualize( filename_prefix + "_factor_" + DSC::to_string(ii) + "_" + filename_suffix, subsampling, vtk_output_type); } @@ -133,7 +134,8 @@ class ConstDiscreteFunction "Types do not match!"); typedef Stuff::LocalizableFunctionInterface<typename SpaceImp::EntityType, typename SpaceImp::DomainFieldType, SpaceImp::dimDomain, typename SpaceImp::RangeFieldType, - SpaceImp::dimRange, SpaceImp::dimRangeCols> BaseType; + SpaceImp::dimRange, SpaceImp::dimRangeCols> + BaseType; typedef ConstDiscreteFunction<SpaceImp, VectorImp> ThisType; public: @@ -363,8 +365,8 @@ auto discrete_function = make_discrete_function< VectorType >(space); \endcode */ template <class VectorType, class SpaceType> -DiscreteFunction<SpaceType, VectorType> make_discrete_function(const SpaceType& space, - const std::string nm = "gdt.discretefunction") +DiscreteFunction<SpaceType, VectorType> +make_discrete_function(const SpaceType& space, const std::string nm = "gdt.discretefunction") { return DiscreteFunction<SpaceType, VectorType>(space, nm); } diff --git a/dune/gdt/discretizations/default.hh b/dune/gdt/discretizations/default.hh index aaacdc28f8a85e07b836ad6c2582761e706b2399..4d8d2229860fbc08b106cf5d21d776eb3e616090 100644 --- a/dune/gdt/discretizations/default.hh +++ b/dune/gdt/discretizations/default.hh @@ -62,7 +62,8 @@ class HyperbolicFVDefaultDiscretizationTraits // no checks of the arguments needed, those are done in the interfaces public: typedef HyperbolicFVDefaultDiscretization<TestCaseImp, FVSpaceImp, numerical_flux, time_stepper_method, - rhs_time_stepper_method> derived_type; + rhs_time_stepper_method> + derived_type; typedef typename TestCaseImp::ProblemType ProblemType; typedef FVSpaceImp SpaceType; typedef typename SpaceType::RangeFieldType RangeFieldType; @@ -299,7 +300,8 @@ class HyperbolicFVDefaultDiscretization rhs_time_stepper_method>> BaseType; typedef HyperbolicFVDefaultDiscretization<TestCaseImp, FVSpaceImp, numerical_flux, time_stepper_method, - rhs_time_stepper_method> ThisType; + rhs_time_stepper_method> + ThisType; public: typedef TestCaseImp TestCaseType; @@ -319,7 +321,8 @@ private: typedef typename ProblemType::DomainFieldType DomainFieldType; typedef typename ProblemType::RangeFieldType RangeFieldType; typedef typename Dune::Stuff::Functions::Constant<typename SpaceType::EntityType, DomainFieldType, dimDomain, - RangeFieldType, 1, 1> ConstantFunctionType; + RangeFieldType, 1, 1> + ConstantFunctionType; typedef typename Dune::GDT::AdvectionRHSOperator<RHSType> RHSOperatorType; typedef typename std:: conditional<numerical_flux == NumericalFluxes::laxfriedrichs @@ -334,8 +337,8 @@ private: time_stepper_method>::TimeStepperType OperatorTimeStepperType; typedef typename TimeStepperFactory<RHSOperatorType, DiscreteFunctionType, RangeFieldType, rhs_time_stepper_method>::TimeStepperType RHSOperatorTimeStepperType; - typedef - typename Dune::GDT::FractionalTimeStepper<OperatorTimeStepperType, RHSOperatorTimeStepperType> TimeStepperType; + typedef typename Dune::GDT::FractionalTimeStepper<OperatorTimeStepperType, RHSOperatorTimeStepperType> + TimeStepperType; public: HyperbolicFVDefaultDiscretization(const TestCaseImp& tst_cs, const std::shared_ptr<const SpaceType> fv_space_ptr) diff --git a/dune/gdt/functionals/base.hh b/dune/gdt/functionals/base.hh index eaba9f57fe3111629ead7d0a728a8fddfe5ae97a..00e2925944b755e1ba9228e3e5935c7ae48b2eaf 100644 --- a/dune/gdt/functionals/base.hh +++ b/dune/gdt/functionals/base.hh @@ -117,7 +117,8 @@ public: { typedef internal::LocalVolumeFunctionalWrapper<ThisType, typename LocalVolumeFunctionalInterface<F>::derived_type, - VectorType> WrapperType; + VectorType> + WrapperType; this->codim0_functors_.emplace_back( new WrapperType(this->test_space_, where, local_volume_functional.as_imp(), vector_.access())); } @@ -129,7 +130,8 @@ public: { typedef internal::LocalFaceFunctionalWrapper<ThisType, typename LocalFaceFunctionalInterface<F>::derived_type, - VectorType> WrapperType; + VectorType> + WrapperType; this->codim1_functors_.emplace_back( new WrapperType(this->test_space_, where, local_face_functional.as_imp(), vector_.access())); } diff --git a/dune/gdt/functionals/elliptic-ipdg.hh b/dune/gdt/functionals/elliptic-ipdg.hh index 31b6f64317fba49d113eabb0ef40a6d3e635d2ec..87032b3dfe4fb893ad3d93d483aa665a2a375cee 100644 --- a/dune/gdt/functionals/elliptic-ipdg.hh +++ b/dune/gdt/functionals/elliptic-ipdg.hh @@ -33,7 +33,7 @@ namespace GDT { template <class DirichletType, class DiffusionFactorType, class DiffusionTensorType, // <- may be void class Space, LocalEllipticIpdgIntegrands::Method method = LocalEllipticIpdgIntegrands::default_method, - class Vector = typename Stuff::LA::Container<typename Space::RangeFieldType>::VectorType, + class Vector = typename Stuff::LA::Container<typename Space::RangeFieldType>::VectorType, class GridView = typename Space::GridViewType, class Field = typename Space::RangeFieldType> class EllipticIpdgDirichletVectorFunctional : public VectorFunctionalBase<Vector, Space, GridView, Field> { @@ -111,7 +111,8 @@ public: private: const LocalFaceIntegralFunctional<LocalEllipticIpdgIntegrands::BoundaryRHS<DirichletType, DiffusionFactorType, - DiffusionTensorType>> local_functional_; + DiffusionTensorType>> + local_functional_; }; // class EllipticIpdgDirichletVectorFunctional diff --git a/dune/gdt/local/assembler.hh b/dune/gdt/local/assembler.hh index c387269d1d3e76a1daea66c9576cfea06e73fa8b..dfe995a31bd385f5932ab3f5947343fc1bb8e210 100644 --- a/dune/gdt/local/assembler.hh +++ b/dune/gdt/local/assembler.hh @@ -73,7 +73,7 @@ public: assert(global_col_indices.size() == cols); for (size_t ii = 0; ii < rows; ++ii) { const auto& local_matrix_row = local_matrix[ii]; - const size_t global_ii = global_row_indices[ii]; + const size_t global_ii = global_row_indices[ii]; for (size_t jj = 0; jj < cols; ++jj) { const size_t global_jj = global_col_indices[jj]; global_matrix.add_to_entry(global_ii, global_jj, local_matrix_row[jj]); @@ -99,7 +99,8 @@ class LocalVolumeTwoFormAccumulator : public Stuff::Grid::internal::Codim0Return "AnsatzFunctionType has to be derived from Stuff::LocalizableFunctionInterface!"); typedef LocalVolumeTwoFormAccumulator<GridViewImp, LocalVolumeTwoFormType, TestFunctionType, AnsatzFunctionType, - FieldType> ThisType; + FieldType> + ThisType; typedef Stuff::Grid::internal::Codim0ReturnObject<GridViewImp, FieldType> BaseType; public: @@ -120,7 +121,7 @@ public: } LocalVolumeTwoFormAccumulator(const ThisType& other) = default; - virtual ~LocalVolumeTwoFormAccumulator() = default; + virtual ~LocalVolumeTwoFormAccumulator() = default; virtual bool apply_on(const GridViewType& grid_view, const EntityType& entity) const override final { @@ -286,7 +287,7 @@ public: for (size_t ii = 0; ii < rows_en; ++ii) { const auto& local_matrix_en_en_row = local_matrix_en_en[ii]; const auto& local_matrix_en_ne_row = local_matrix_en_ne[ii]; - const size_t global_ii = global_row_indices_en[ii]; + const size_t global_ii = global_row_indices_en[ii]; for (size_t jj = 0; jj < cols_en; ++jj) { const size_t global_jj = global_col_indices_en[jj]; global_matrix_en_en.add_to_entry(global_ii, global_jj, local_matrix_en_en_row[jj]); @@ -299,7 +300,7 @@ public: for (size_t ii = 0; ii < rows_ne; ++ii) { const auto& local_matrix_ne_en_row = local_matrix_ne_en[ii]; const auto& local_matrix_ne_ne_row = local_matrix_ne_ne[ii]; - const size_t global_ii = global_row_indices_ne[ii]; + const size_t global_ii = global_row_indices_ne[ii]; for (size_t jj = 0; jj < cols_en; ++jj) { const size_t global_jj = global_col_indices_en[jj]; global_matrix_ne_en.add_to_entry(global_ii, global_jj, local_matrix_ne_en_row[jj]); @@ -421,7 +422,7 @@ public: assert(global_col_indices.size() == cols); for (size_t ii = 0; ii < rows; ++ii) { const auto& local_matrix_row = local_matrix[ii]; - const size_t global_ii = global_row_indices[ii]; + const size_t global_ii = global_row_indices[ii]; for (size_t jj = 0; jj < cols; ++jj) { const size_t global_jj = global_col_indices[jj]; global_matrix.add_to_entry(global_ii, global_jj, local_matrix_row[jj]); @@ -545,7 +546,7 @@ public: // prepare const auto entity_ptr = intersection.inside(); const auto& entity = *entity_ptr; - const size_t size = test_space.mapper().numDofs(entity); + const size_t size = test_space.mapper().numDofs(entity); Dune::DynamicVector<R> local_vector(size, 0.); // \todo: make mutable member, after SMP refactor // apply local functional const auto test_basis = test_space.base_function_set(entity); diff --git a/dune/gdt/local/discretefunction.hh b/dune/gdt/local/discretefunction.hh index e23a9a5e31bb6b5361dad253bb035db66f90fcc1..a584f242be587ad80003cdfa931b9e6fea952883 100644 --- a/dune/gdt/local/discretefunction.hh +++ b/dune/gdt/local/discretefunction.hh @@ -44,7 +44,8 @@ class ConstLocalDiscreteFunction "Types do not match!"); typedef Stuff::LocalfunctionInterface<typename SpaceImp::EntityType, typename SpaceImp::DomainFieldType, SpaceImp::dimDomain, typename SpaceImp::RangeFieldType, SpaceImp::dimRange, - SpaceImp::dimRangeCols> BaseType; + SpaceImp::dimRangeCols> + BaseType; typedef ConstLocalDiscreteFunction<SpaceImp, VectorImp> ThisType; public: @@ -121,7 +122,7 @@ public: } } else { for (size_t ii = 0; ii < localVector_->size(); ++ii) - ret[ii] = localVector_->get(ii); + ret[ii] = localVector_->get(ii); } } // ... evaluate(...) diff --git a/dune/gdt/local/dof-vector.hh b/dune/gdt/local/dof-vector.hh index 5a04c70219277d44a38f86b3f1e8faa8db864542..f34e691962ae579fe1b65e9aa9145c7b998059c6 100644 --- a/dune/gdt/local/dof-vector.hh +++ b/dune/gdt/local/dof-vector.hh @@ -66,7 +66,8 @@ private: template <class V> -std::ostream& operator<<(std::ostream& out, const ConstLocalDoFVector<V>& vector) +std::ostream& +operator<<(std::ostream& out, const ConstLocalDoFVector<V>& vector) { out << "["; const size_t sz = vector.size(); diff --git a/dune/gdt/local/fluxes/godunov.hh b/dune/gdt/local/fluxes/godunov.hh index 55f0d26a950715f2a91dd9323d0894d6bc378c67..8e9b2ff009783bda5126237ee7da87b45283fe32 100644 --- a/dune/gdt/local/fluxes/godunov.hh +++ b/dune/gdt/local/fluxes/godunov.hh @@ -66,7 +66,7 @@ public: typedef typename AnalyticalFluxType::FluxJacobianRangeType FluxJacobianRangeType; typedef std::tuple<double> LocalfunctionTupleType; static const size_t dimDomain = domainDim; - static const size_t dimRange = AnalyticalFluxType::dimRange; + static const size_t dimRange = AnalyticalFluxType::dimRange; static_assert(AnalyticalFluxType::dimRangeCols == 1, "Not implemented for dimRangeCols > 1!"); typedef typename Dune::Stuff::LA::EigenDenseMatrix<RangeFieldType> EigenMatrixType; }; // class LocalGodunovNumericalCouplingFluxTraits @@ -156,7 +156,7 @@ public: coord = ii; #ifndef NDEBUG else if (DSC::FloatCmp::eq(n_ij[ii], RangeFieldType(0))) - ++num_zeros; + ++num_zeros; else DUNE_THROW(Dune::NotImplemented, "Godunov flux is only implemented for axis parallel cube grids"); #endif // NDEBUG @@ -169,12 +169,12 @@ public: RangeType negative_waves(RangeFieldType(0)); jacobian_neg_[coord].mv(delta_u, negative_waves); for (size_t kk = 0; kk < dimRange; ++kk) - ret[kk] = (f_u_i[kk][coord] - negative_waves[kk] * n_ij[coord]) * vol_intersection; + ret[kk] = (f_u_i[kk][coord] - negative_waves[kk] * n_ij[coord]) * vol_intersection; } else { RangeType positive_waves(RangeFieldType(0)); jacobian_pos_[coord].mv(delta_u, positive_waves); for (size_t kk = 0; kk < dimRange; ++kk) - ret[kk] = (-f_u_i[kk][coord] - positive_waves[kk] * n_ij[coord]) * vol_intersection; + ret[kk] = (-f_u_i[kk][coord] - positive_waves[kk] * n_ij[coord]) * vol_intersection; } return ret; } // RangeType evaluate(...) const @@ -277,7 +277,8 @@ public: static const size_t dimDomain = Traits::dimDomain; static const size_t dimRange = Traits::dimRange; typedef typename DS::Functions::Affine<typename AnalyticalFluxType::FluxDummyEntityType, RangeFieldType, dimRange, - RangeFieldType, dimRange, 1> AffineFunctionType; + RangeFieldType, dimRange, 1> + AffineFunctionType; explicit LocalGodunovNumericalCouplingFlux(const AnalyticalFluxType& analytical_flux, const bool is_linear, const bool reinit_jacobians = true) @@ -382,8 +383,8 @@ private: DSC::to_string(jacobian_neg_eigen, 15)); jacobian_pos_ = DSC::from_string<Dune::FieldMatrix<RangeFieldType, dimRange, dimRange>>( DSC::to_string(jacobian_pos_eigen, 15)); - jacobian_neg_function_ = AffineFunctionType(jacobian_neg_, RangeType(0), true); - jacobian_pos_function_ = AffineFunctionType(jacobian_pos_, RangeType(0), true); + jacobian_neg_function_ = AffineFunctionType(jacobian_neg_, RangeType(0), true); + jacobian_pos_function_ = AffineFunctionType(jacobian_pos_, RangeType(0), true); } } // void calculate_jacobians(...) @@ -430,7 +431,8 @@ class LocalGodunovNumericalBoundaryFlux { public: typedef internal::LocalGodunovNumericalBoundaryFluxTraits<AnalyticalBoundaryFluxImp, BoundaryValueFunctionImp, - domainDim> Traits; + domainDim> + Traits; typedef typename Traits::BoundaryValueFunctionType BoundaryValueFunctionType; typedef typename Traits::LocalfunctionTupleType LocalfunctionTupleType; typedef typename Traits::EntityType EntityType; @@ -470,7 +472,7 @@ public: { const auto x_intersection_entity_coords = intersection.geometryInInside().global(x_intersection); const RangeType u_i = local_source_entity.evaluate(x_intersection_entity_coords); - const RangeType u_j = std::get<0>(local_functions_tuple)->evaluate(x_intersection_entity_coords); + const RangeType u_j = std::get<0>(local_functions_tuple)->evaluate(x_intersection_entity_coords); // get flux values const FluxRangeType f_u_i = analytical_flux_.evaluate(u_i); @@ -491,7 +493,7 @@ public: coord = ii; #ifndef NDEBUG else if (DSC::FloatCmp::eq(n_ij[ii], RangeFieldType(0))) - ++num_zeros; + ++num_zeros; else DUNE_THROW(Dune::NotImplemented, "Godunov flux is only implemented for axis parallel cube grids"); #endif // NDEBUG @@ -504,12 +506,12 @@ public: RangeType negative_waves(RangeFieldType(0)); jacobian_neg_[coord].mv(delta_u, negative_waves); for (size_t kk = 0; kk < dimRange; ++kk) - ret[kk] = (f_u_i[kk][coord] - negative_waves[kk] * n_ij[coord]) * vol_intersection; + ret[kk] = (f_u_i[kk][coord] - negative_waves[kk] * n_ij[coord]) * vol_intersection; } else { RangeType positive_waves(RangeFieldType(0)); jacobian_pos_[coord].mv(delta_u, positive_waves); for (size_t kk = 0; kk < dimRange; ++kk) - ret[kk] = (-f_u_i[kk][coord] - positive_waves[kk] * n_ij[coord]) * vol_intersection; + ret[kk] = (-f_u_i[kk][coord] - positive_waves[kk] * n_ij[coord]) * vol_intersection; } return ret; } // void evaluate(...) const @@ -617,7 +619,8 @@ public: static const size_t dimDomain = Traits::dimDomain; static const size_t dimRange = Traits::dimRange; typedef typename DS::Functions::Affine<typename AnalyticalFluxType::FluxDummyEntityType, RangeFieldType, dimRange, - RangeFieldType, dimRange, 1> AffineFunctionType; + RangeFieldType, dimRange, 1> + AffineFunctionType; explicit LocalGodunovNumericalBoundaryFlux(const AnalyticalFluxType& analytical_flux, const BoundaryValueFunctionType& boundary_values, const bool is_linear = false, const bool reinit_jacobians = true) @@ -643,7 +646,7 @@ public: { const auto x_intersection_entity_coords = intersection.geometryInInside().global(x_intersection); const RangeType u_i = local_source_entity.evaluate(x_intersection_entity_coords); - const RangeType u_j = std::get<0>(local_functions_tuple)->evaluate(x_intersection_entity_coords); + const RangeType u_j = std::get<0>(local_functions_tuple)->evaluate(x_intersection_entity_coords); if (!jacobians_constructed_ && is_linear_) initialize_jacobians(); diff --git a/dune/gdt/local/fluxes/interfaces.hh b/dune/gdt/local/fluxes/interfaces.hh index a6f979ee8de8cb7bcf8b038468168bc527f3d351..e7d4561b688f52dec94d168ceae96854a11e094f 100644 --- a/dune/gdt/local/fluxes/interfaces.hh +++ b/dune/gdt/local/fluxes/interfaces.hh @@ -212,7 +212,7 @@ public: return jacobian(u); } - virtual FluxRangeType evaluate(const RangeType& u) const = 0; + virtual FluxRangeType evaluate(const RangeType& u) const = 0; virtual FluxJacobianRangeType jacobian(const RangeType& u) const = 0; }; diff --git a/dune/gdt/local/fluxes/laxfriedrichs.hh b/dune/gdt/local/fluxes/laxfriedrichs.hh index 1520fc59e025c45bea83187fec06989b538555ef..fe688f338165150d72261722ba4453af28b40369 100644 --- a/dune/gdt/local/fluxes/laxfriedrichs.hh +++ b/dune/gdt/local/fluxes/laxfriedrichs.hh @@ -79,7 +79,8 @@ public: typedef BoundaryValueFunctionImp BoundaryValueFunctionType; typedef typename BoundaryValueFunctionType::LocalfunctionType BoundaryValueLocalfunctionType; typedef LocalLaxFriedrichsDirichletNumericalBoundaryFlux<AnalyticalFluxImp, BoundaryValueFunctionImp, - LocalizableFunctionImp, domainDim> derived_type; + LocalizableFunctionImp, domainDim> + derived_type; typedef std::tuple<std::shared_ptr<LocalfunctionType>, std::shared_ptr<BoundaryValueLocalfunctionType>> LocalfunctionTupleType; }; // class LocalLaxFriedrichsDirichletNumericalBoundaryFluxTraits @@ -154,8 +155,8 @@ public: const Dune::FieldVector<DomainFieldType, dimDomain - 1>& x_intersection) const { // get function values - const RangeType u_i = local_source_entity.evaluate(intersection.geometryInInside().global(x_intersection)); - RangeType u_j = local_source_neighbor.evaluate(intersection.geometryInOutside().global(x_intersection)); + const RangeType u_i = local_source_entity.evaluate(intersection.geometryInInside().global(x_intersection)); + RangeType u_j = local_source_neighbor.evaluate(intersection.geometryInOutside().global(x_intersection)); FluxRangeType f_u_i_plus_f_u_j = analytical_flux_.evaluate(u_i); f_u_i_plus_f_u_j += analytical_flux_.evaluate(u_j); auto n_ij = intersection.unitOuterNormal(x_intersection); @@ -245,7 +246,7 @@ public: n_ij[coord] *= 0.5 * vol_intersection_; // calculate flux for (size_t kk = 0; kk < dimRange; ++kk) - ret[kk] = f_u_i_plus_f_u_j[kk][coord] * n_ij[coord] - u_j[kk]; + ret[kk] = f_u_i_plus_f_u_j[kk][coord] * n_ij[coord] - u_j[kk]; return ret; } // RangeType evaluate(...) const @@ -432,7 +433,8 @@ class LocalLaxFriedrichsDirichletNumericalBoundaryFlux { public: typedef internal::LocalLaxFriedrichsDirichletNumericalBoundaryFluxTraits<AnalyticalFluxImp, BoundaryValueFunctionImp, - LocalizableFunctionImp, domainDim> Traits; + LocalizableFunctionImp, domainDim> + Traits; typedef typename Traits::BoundaryValueFunctionType BoundaryValueFunctionType; typedef typename Traits::LocalizableFunctionType LocalizableFunctionType; typedef typename Traits::LocalfunctionTupleType LocalfunctionTupleType; @@ -479,7 +481,7 @@ public: // get function values const auto x_intersection_entity_coords = intersection.geometryInInside().global(x_intersection); const RangeType u_i = local_source_entity.evaluate(x_intersection_entity_coords); - auto u_j = std::get<1>(local_functions_tuple)->evaluate(x_intersection_entity_coords); + auto u_j = std::get<1>(local_functions_tuple)->evaluate(x_intersection_entity_coords); FluxRangeType f_u_i_plus_f_u_j = analytical_flux_.evaluate(u_i); f_u_i_plus_f_u_j += analytical_flux_.evaluate(u_j); auto n_ij = intersection.unitOuterNormal(x_intersection); @@ -568,7 +570,7 @@ public: n_ij[coord] *= 0.5 * vol_intersection_; // calculate flux for (size_t kk = 0; kk < dimRange; ++kk) - ret[kk] = f_u_i_plus_f_u_j[kk][coord] * n_ij[coord] - u_j[kk]; + ret[kk] = f_u_i_plus_f_u_j[kk][coord] * n_ij[coord] - u_j[kk]; return ret; } // RangeType evaluate(...) const @@ -620,7 +622,8 @@ class LocalLaxFriedrichsDirichletNumericalBoundaryFlux<AnalyticalFluxImp, Bounda { public: typedef internal::LocalLaxFriedrichsDirichletNumericalBoundaryFluxTraits<AnalyticalFluxImp, BoundaryValueFunctionImp, - LocalizableFunctionImp, 1> Traits; + LocalizableFunctionImp, 1> + Traits; typedef typename Traits::BoundaryValueFunctionType BoundaryValueFunctionType; typedef typename Traits::LocalizableFunctionType LocalizableFunctionType; typedef typename Traits::LocalfunctionTupleType LocalfunctionTupleType; @@ -665,11 +668,11 @@ public: // get function values const auto x_intersection_entity_coords = intersection.geometryInInside().global(x_intersection); RangeType u_i = local_source_entity.evaluate(x_intersection_entity_coords); - const auto u_j = std::get<1>(local_functions_tuple)->evaluate(x_intersection_entity_coords); + const auto u_j = std::get<1>(local_functions_tuple)->evaluate(x_intersection_entity_coords); const auto n_ij = intersection.unitOuterNormal(x_intersection); const RangeFieldType dx = std::get<0>(local_functions_tuple)->evaluate(x_intersection_entity_coords)[0]; - *max_derivative_ = dx / dt_; + *max_derivative_ = dx / dt_; if (use_local_) { if (!is_linear_ || !(*max_derivative_calculated_)) { *max_derivative_ = 0; @@ -766,7 +769,8 @@ class LocalLaxFriedrichsAbsorbingNumericalBoundaryFlux { public: typedef internal::LocalLaxFriedrichsAbsorbingNumericalBoundaryFluxTraits<AnalyticalFluxImp, LocalizableFunctionImp, - domainDim> Traits; + domainDim> + Traits; typedef typename Traits::LocalizableFunctionType LocalizableFunctionType; typedef typename Traits::LocalfunctionTupleType LocalfunctionTupleType; typedef typename Traits::EntityType EntityType; @@ -798,7 +802,7 @@ public: const Dune::FieldVector<DomainFieldType, dimDomain - 1>& x_intersection) const { // get function values - const RangeType u_i = local_source_entity.evaluate(intersection.geometryInInside().global(x_intersection)); + const RangeType u_i = local_source_entity.evaluate(intersection.geometryInInside().global(x_intersection)); const FluxRangeType f_u_i_temp = analytical_flux_.evaluate(u_i); DSC::FieldMatrix<RangeFieldType, dimRange, dimDomain> f_u_i; for (size_t ii = 0; ii < dimRange; ++ii) { @@ -811,7 +815,7 @@ public: } RangeType ret; for (size_t kk = 0; kk < dimRange; ++kk) - ret[0][kk] = (f_u_i[kk] + f_u_i[kk]) * n_ij * 0.5 * vol_intersection; + ret[0][kk] = (f_u_i[kk] + f_u_i[kk]) * n_ij * 0.5 * vol_intersection; return ret; } // void evaluate(...) const diff --git a/dune/gdt/local/functionals/integrals.hh b/dune/gdt/local/functionals/integrals.hh index 5c9f6b1719d001cc18da58eab4436714b9cfb9e4..ba158f1ec8d3aaeeefdc488f9586cc009d18077a 100644 --- a/dune/gdt/local/functionals/integrals.hh +++ b/dune/gdt/local/functionals/integrals.hh @@ -84,7 +84,7 @@ public: } LocalVolumeIntegralFunctional(const ThisType& other) = default; - LocalVolumeIntegralFunctional(ThisType&& source) = default; + LocalVolumeIntegralFunctional(ThisType&& source) = default; template <class E, class D, size_t d, class R, size_t r, size_t rC> void apply(const Stuff::LocalfunctionSetInterface<E, D, d, R, r, rC>& test_base, Dune::DynamicVector<R>& ret) const @@ -93,7 +93,7 @@ public: const auto local_functions = integrand_.localFunctions(entity); // create quadrature const size_t integrand_order = integrand_.order(local_functions, test_base) + over_integrate_; - const auto& quadrature = QuadratureRules<D, d>::rule(entity.type(), boost::numeric_cast<int>(integrand_order)); + const auto& quadrature = QuadratureRules<D, d>::rule(entity.type(), boost::numeric_cast<int>(integrand_order)); // prepare storage const size_t size = test_base.size(); ret *= 0.0; diff --git a/dune/gdt/local/integrands/ESV2007.hh b/dune/gdt/local/integrands/ESV2007.hh index 0b59e95290b749773aa5c7893d5b6a5a82b57b10..77db54ca2048c84775c98701030798e7acef332e 100644 --- a/dune/gdt/local/integrands/ESV2007.hh +++ b/dune/gdt/local/integrands/ESV2007.hh @@ -59,7 +59,8 @@ public: derived_type; typedef std::tuple<std::shared_ptr<typename DiffusionFactorType::LocalfunctionType>, std::shared_ptr<typename DiffusionTensorType::LocalfunctionType>, - std::shared_ptr<typename DiffusiveFluxType::LocalfunctionType>> LocalfunctionTupleType; + std::shared_ptr<typename DiffusiveFluxType::LocalfunctionType>> + LocalfunctionTupleType; typedef typename DiffusionFactorType::EntityType EntityType; typedef typename DiffusionFactorType::DomainFieldType DomainFieldType; static const size_t dimDomain = DiffusionFactorType::dimDomain; @@ -83,7 +84,8 @@ class LocalDiffusiveFluxEstimateESV2007IntegrandTraits<DiffusionType, DiffusiveF public: typedef LocalDiffusiveFluxEstimateESV2007Integrand<DiffusionType, DiffusiveFluxType> derived_type; typedef std::tuple<std::shared_ptr<typename DiffusionType::LocalfunctionType>, - std::shared_ptr<typename DiffusiveFluxType::LocalfunctionType>> LocalfunctionTupleType; + std::shared_ptr<typename DiffusiveFluxType::LocalfunctionType>> + LocalfunctionTupleType; typedef typename DiffusionType::EntityType EntityType; typedef typename DiffusionType::DomainFieldType DomainFieldType; static const size_t dimDomain = DiffusionType::dimDomain; @@ -102,7 +104,8 @@ class LocalDiffusiveFluxEstimateESV2007Integrand<DiffusionType, DiffusiveFluxTyp { typedef LocalVolumeIntegrandInterface<internal::LocalDiffusiveFluxEstimateESV2007IntegrandTraits<DiffusionType, DiffusiveFluxType>, - 2> BaseType; + 2> + BaseType; public: typedef internal::LocalDiffusiveFluxEstimateESV2007IntegrandTraits<DiffusionType, DiffusiveFluxType> Traits; @@ -187,12 +190,12 @@ public: // evaluate test gradient const size_t rows = test_base.size(); const auto test_gradients = test_base.jacobian(local_point); - auto left_sum = test_gradients[0]; + auto left_sum = test_gradients[0]; assert(test_gradients.size() == rows); // evaluate ansatz gradient const size_t cols = ansatz_base.size(); const auto ansatz_gradients = ansatz_base.jacobian(local_point); - auto right_sum = ansatz_gradients[0]; + auto right_sum = ansatz_gradients[0]; assert(ansatz_gradients.size() == rows); // compute assert(ret.rows() >= rows); @@ -230,11 +233,13 @@ class LocalDiffusiveFluxEstimateESV2007Integrand typedef LocalVolumeIntegrandInterface<internal::LocalDiffusiveFluxEstimateESV2007IntegrandTraits<DiffusionFactorType, DiffusiveFluxType, DiffusionTensorType>, - 2> BaseType; + 2> + BaseType; public: typedef internal::LocalDiffusiveFluxEstimateESV2007IntegrandTraits<DiffusionFactorType, DiffusiveFluxType, - DiffusionTensorType> Traits; + DiffusionTensorType> + Traits; using typename BaseType::LocalfunctionTupleType; using typename BaseType::EntityType; using typename BaseType::DomainFieldType; @@ -268,7 +273,7 @@ public: { const auto local_diffusion_factor = std::get<0>(localFuncs); const auto local_diffusion_tensor = std::get<1>(localFuncs); - const auto local_diffusive_flux = std::get<2>(localFuncs); + const auto local_diffusive_flux = std::get<2>(localFuncs); return order(*local_diffusion_factor, *local_diffusion_tensor, *local_diffusive_flux, testBase, ansatzBase); } // ... order(...) @@ -281,7 +286,7 @@ public: { const auto local_diffusion_factor = std::get<0>(localFuncs); const auto local_diffusion_tensor = std::get<1>(localFuncs); - const auto local_diffusive_flux = std::get<2>(localFuncs); + const auto local_diffusive_flux = std::get<2>(localFuncs); evaluate(*local_diffusion_factor, *local_diffusion_tensor, *local_diffusive_flux, diff --git a/dune/gdt/local/integrands/elliptic-ipdg.hh b/dune/gdt/local/integrands/elliptic-ipdg.hh index 2ec28a626c34494c03ffb0461ef1eda78c808727..acabf385f153a9382f279f8d5d6ff74049a251ce 100644 --- a/dune/gdt/local/integrands/elliptic-ipdg.hh +++ b/dune/gdt/local/integrands/elliptic-ipdg.hh @@ -95,7 +95,8 @@ public: typedef typename EllipticType::DiffusionTensorType DiffusionTensorType; typedef std::tuple<std::shared_ptr<typename DirichletType::LocalfunctionType>, std::shared_ptr<typename DiffusionFactorType::LocalfunctionType>, - std::shared_ptr<typename DiffusionTensorType::LocalfunctionType>> LocalfunctionTupleType; + std::shared_ptr<typename DiffusionTensorType::LocalfunctionType>> + LocalfunctionTupleType; typedef typename EllipticType::EntityType EntityType; typedef typename EllipticType::DomainFieldType DomainFieldType; static const size_t dimDomain = EllipticType::dimDomain; @@ -151,7 +152,7 @@ public: } Inner(const ThisType& other) = default; - Inner(ThisType&& source) = default; + Inner(ThisType&& source) = default; /// \name Required by LocalFaceIntegrandInterface< ..., 4 >. /// \{ @@ -468,8 +469,8 @@ public: const TensorType local_diffusion_tensor_value_en = local_diffusion_tensor_en.evaluate(local_point_en); const auto local_diffusion_factor_value_ne = local_diffusion_factor_ne.evaluate(local_point_ne); const TensorType local_diffusion_tensor_value_ne = local_diffusion_tensor_ne.evaluate(local_point_ne); - const auto diffusion_value_en = local_diffusion_tensor_value_en * local_diffusion_factor_value_en; - const auto diffusion_value_ne = local_diffusion_tensor_value_ne * local_diffusion_factor_value_ne; + const auto diffusion_value_en = local_diffusion_tensor_value_en * local_diffusion_factor_value_en; + const auto diffusion_value_ne = local_diffusion_tensor_value_ne * local_diffusion_factor_value_ne; // // this evaluation has to be linear wrt the diffusion factor, so no other averaging method is allowed here! // const auto local_diffusion_factor = (local_diffusion_factor_en + local_diffusion_factor_ne) * 0.5; // compute penalty factor (see Epshteyn, Riviere, 2007) @@ -477,10 +478,10 @@ public: test_base_en.order(), std::max(ansatz_base_en.order(), std::max(test_base_ne.order(), ansatz_base_ne.order()))); const R sigma = LocalSipdgIntegrands::internal::inner_sigma(max_polorder); // compute weighting (see Ern, Stephansen, Zunino 2007) - const R delta_plus = normal * (/*local_diffusion_tensor_ne*/ diffusion_value_ne * normal); - const R delta_minus = normal * (/*local_diffusion_tensor_en*/ diffusion_value_en * normal); - const R gamma = (delta_plus * delta_minus) / (delta_plus + delta_minus); - const R penalty = (/*local_diffusion_factor **/ sigma * gamma) / std::pow(intersection.geometry().volume(), beta_); + const R delta_plus = normal * (/*local_diffusion_tensor_ne*/ diffusion_value_ne * normal); + const R delta_minus = normal * (/*local_diffusion_tensor_en*/ diffusion_value_en * normal); + const R gamma = (delta_plus * delta_minus) / (delta_plus + delta_minus); + const R penalty = (/*local_diffusion_factor **/ sigma * gamma) / std::pow(intersection.geometry().volume(), beta_); const R weight_plus = delta_minus / (delta_plus + delta_minus); const R weight_minus = delta_plus / (delta_plus + delta_minus); // evaluate bases @@ -615,7 +616,7 @@ public: } BoundaryLHS(const ThisType& other) = default; - BoundaryLHS(ThisType&& source) = default; + BoundaryLHS(ThisType&& source) = default; /// \name Required by LocalFaceIntegrandInterface< ..., 2 > @@ -881,7 +882,7 @@ public: } BoundaryRHS(const ThisType& other) = default; - BoundaryRHS(ThisType&& source) = default; + BoundaryRHS(ThisType&& source) = default; /// \name Required by LocalFaceIntegrandInterface< ..., 1 >. /// \{ @@ -937,7 +938,7 @@ public: const size_t test_order = test_base.order(); const size_t test_gradient_order = std::max(ssize_t(test_order) - 1, ssize_t(0)); const size_t diffusionOrder = local_diffusion_factor.order() + local_diffusion_tensor.order(); - const size_t dirichletOrder = local_dirichlet.order(); + const size_t dirichletOrder = local_dirichlet.order(); return std::max(test_order + dirichletOrder, diffusionOrder + test_gradient_order + dirichletOrder); } // ... order(...) diff --git a/dune/gdt/local/integrands/elliptic.hh b/dune/gdt/local/integrands/elliptic.hh index 11796e9fb0fa95ab63affff36501f74181f4aba4..09384c02e0321866baefc1a9c6a1d9bbd3ae561b 100644 --- a/dune/gdt/local/integrands/elliptic.hh +++ b/dune/gdt/local/integrands/elliptic.hh @@ -116,7 +116,8 @@ public: typedef typename Helper<single_factor_given, single_tensor_given>::TensorType DiffusionTensorType; typedef LocalEllipticIntegrand<DiffusionFactorType, DiffusionTensorType> derived_type; typedef std::tuple<std::shared_ptr<typename DiffusionFactorType::LocalfunctionType>, - std::shared_ptr<typename DiffusionTensorType::LocalfunctionType>> LocalfunctionTupleType; + std::shared_ptr<typename DiffusionTensorType::LocalfunctionType>> + LocalfunctionTupleType; }; // class LocalEllipticIntegrandTraits @@ -133,7 +134,8 @@ class LocalEllipticIntegrand 2> { typedef LocalVolumeIntegrandInterface<internal::LocalEllipticIntegrandTraits<DiffusionFactorImp, DiffusionTensorImp>, - 2> BaseType; + 2> + BaseType; typedef LocalEllipticIntegrand<DiffusionFactorImp, DiffusionTensorImp> ThisType; public: @@ -178,7 +180,7 @@ public: } LocalEllipticIntegrand(const ThisType& other) = default; - LocalEllipticIntegrand(ThisType&& source) = default; + LocalEllipticIntegrand(ThisType&& source) = default; /// \name Required by LocalVolumeIntegrandInterface< ..., 2 > /// \{ diff --git a/dune/gdt/local/integrands/sipdg.hh b/dune/gdt/local/integrands/sipdg.hh index eccb2af3bb149ed5c6b06565c8130dedc6ff75af..47fd81aa9e97143cefea12399efece4a08b43c9d 100644 --- a/dune/gdt/local/integrands/sipdg.hh +++ b/dune/gdt/local/integrands/sipdg.hh @@ -120,7 +120,8 @@ public: /** * \note see Epshteyn, Riviere, 2007 */ -static inline double default_beta(const size_t dimDomain) +static inline double +default_beta(const size_t dimDomain) { return 1.0 / (dimDomain - 1.0); } @@ -129,7 +130,8 @@ static inline double default_beta(const size_t dimDomain) /** * \note see Epshteyn, Riviere, 2007 */ -static inline double inner_sigma(const size_t pol_order) +static inline double +inner_sigma(const size_t pol_order) { double sigma = 1.0; if (pol_order <= 1) @@ -156,7 +158,8 @@ static inline double inner_sigma(const size_t pol_order) /** * \note see Epshteyn, Riviere, 2007 */ -static inline double boundary_sigma(const size_t pol_order) +static inline double +boundary_sigma(const size_t pol_order) { double sigma = 1.0; if (pol_order <= 1) @@ -611,7 +614,7 @@ public: const size_t testOrder = testBase.order(); const size_t testGradientOrder = boost::numeric_cast<size_t>(std::max(ssize_t(testOrder) - 1, ssize_t(0))); const size_t diffusionOrder = localDiffusion.order(); - const size_t dirichletOrder = localDirichlet.order(); + const size_t dirichletOrder = localDirichlet.order(); return std::max(testOrder + dirichletOrder, diffusionOrder + testGradientOrder + dirichletOrder); } // ... order(...) diff --git a/dune/gdt/local/operators/fv.hh b/dune/gdt/local/operators/fv.hh index d5134c9833e8b6901278206a417023d3042e2db1..885b1f531b80e8b84e65eb3c3e56892270c99c21 100644 --- a/dune/gdt/local/operators/fv.hh +++ b/dune/gdt/local/operators/fv.hh @@ -173,13 +173,13 @@ public: const auto local_functions_tuple_entity = numerical_flux_.local_functions(*entity_ptr); const auto local_functions_tuple_neighbor = numerical_flux_.local_functions(*neighbor_ptr); const DSC::FieldVector<typename LocalDiscreteFunction<SpaceType, VectorType>::DomainFieldType, - LocalDiscreteFunction<SpaceType, VectorType>::dimRange> result = - numerical_flux_.evaluate(local_functions_tuple_entity, - local_functions_tuple_neighbor, - *local_source_entity, - *local_source_neighbor, - intersection, - geometry_intersection.local(geometry_intersection.center())); + LocalDiscreteFunction<SpaceType, VectorType>::dimRange> + result = numerical_flux_.evaluate(local_functions_tuple_entity, + local_functions_tuple_neighbor, + *local_source_entity, + *local_source_neighbor, + intersection, + geometry_intersection.local(geometry_intersection.center())); local_range_entity.vector().add(result * (1.0 / entity_ptr->geometry().volume())); local_range_neighbor.vector().add(result * (-1.0 / neighbor_ptr->geometry().volume())); } @@ -239,7 +239,7 @@ public: const auto local_source_entity = source.local_function(entity); const auto x_local = entity.geometry().local(entity.geometry().center()); const auto u = local_source_entity->evaluate(x_local); - const auto result = rhs_evaluation_.evaluate(u, entity, x_local); + const auto result = rhs_evaluation_.evaluate(u, entity, x_local); local_range.vector().add(result); } @@ -289,7 +289,7 @@ public: if (intersection.neighbor()) { const auto neighbor_ptr = intersection.outside(); const auto neighbor_center = neighbor_ptr->geometry().center(); - const bool boundary = intersection.boundary(); + const bool boundary = intersection.boundary(); if ((neighbor_center[0] < entity_center[0] && !boundary) || (neighbor_center[0] > entity_center[0] && boundary)) u_left = source.local_discrete_function(*neighbor_ptr)->evaluate(neighbor_ptr->geometry().local(neighbor_center)); @@ -313,7 +313,7 @@ public: const StuffFieldVectorType w_slope_left = w_entity - w_left; const StuffFieldVectorType w_slope_right = w_right - w_entity; const StuffFieldVectorType w_centered_slope = w_right * RangeFieldType(0.5) - w_left * RangeFieldType(0.5); - const StuffFieldVectorType w_slope = internal::ChooseLimiter<slope_limiter, StuffFieldVectorType>::limit( + const StuffFieldVectorType w_slope = internal::ChooseLimiter<slope_limiter, StuffFieldVectorType>::limit( w_slope_left, w_slope_right, w_centered_slope); const StuffFieldVectorType half_w_slope = w_slope * RangeFieldType(0.5); const StuffFieldVectorType w_reconstructed_left = w_entity - half_w_slope; diff --git a/dune/gdt/local/operators/integrals.hh b/dune/gdt/local/operators/integrals.hh index 62fcdbb3910b728ecc494afa584cf4a5462b2441..6854adc43ccbad6ea85555498072d0f626ccfe6e 100644 --- a/dune/gdt/local/operators/integrals.hh +++ b/dune/gdt/local/operators/integrals.hh @@ -110,7 +110,7 @@ public: } LocalVolumeIntegralOperator(const ThisType& other) = default; - LocalVolumeIntegralOperator(ThisType&& source) = default; + LocalVolumeIntegralOperator(ThisType&& source) = default; using BaseType::apply2; @@ -123,7 +123,7 @@ public: const auto local_functions = integrand_.localFunctions(entity); // create quadrature const size_t integrand_order = integrand_.order(local_functions, ansatz_base, test_base) + over_integrate_; - const auto& quadrature = QuadratureRules<D, d>::rule(entity.type(), boost::numeric_cast<int>(integrand_order)); + const auto& quadrature = QuadratureRules<D, d>::rule(entity.type(), boost::numeric_cast<int>(integrand_order)); // prepare storage const size_t rows = test_base.size(); const size_t cols = ansatz_base.size(); @@ -142,7 +142,7 @@ public: // compute integral for (size_t ii = 0; ii < rows; ++ii) { const auto& evaluation_result_row = evaluation_result[ii]; - auto& ret_row = ret[ii]; + auto& ret_row = ret[ii]; for (size_t jj = 0; jj < cols; ++jj) ret_row[jj] += evaluation_result_row[jj] * integration_factor * quadrature_weight; } // compute integral diff --git a/dune/gdt/local/operators/l2-projection.hh b/dune/gdt/local/operators/l2-projection.hh index b4e2b2528ed49b710d8904c2bbc23c352cbe5c8b..5718338190327e84950c400b5582b317fe3ddfc0 100644 --- a/dune/gdt/local/operators/l2-projection.hh +++ b/dune/gdt/local/operators/l2-projection.hh @@ -81,7 +81,7 @@ public: const LocalVolumeIntegralFunctional<LocalProductIntegrand<SourceType>> local_l2_functional(over_integrate_, source); // create local lhs and rhs const auto& local_basis = local_range.basis(); - const size_t size = local_basis.size(); + const size_t size = local_basis.size(); Stuff::LA::CommonDenseMatrix<R> local_matrix(size, size); Stuff::LA::CommonDenseVector<R> local_vector(size); // assemble diff --git a/dune/gdt/operators/base.hh b/dune/gdt/operators/base.hh index 394c20a65cec523d2076d8de42210e8da3ec77b6..d2c54e652a424eaf4d14230b08ea85ee79bc1644 100644 --- a/dune/gdt/operators/base.hh +++ b/dune/gdt/operators/base.hh @@ -64,7 +64,7 @@ public: * \todo Check parallel case: there is probably/definitely communication missing in apply2! */ template <class GridViewImp, class RangeImp, class SourceImp = RangeImp, - class FieldImp = typename RangeImp::RangeFieldType> + class FieldImp = typename RangeImp::RangeFieldType> class LocalizableProductBase : public Stuff::Grid::Walker<GridViewImp> { typedef Stuff::Grid::Walker<GridViewImp> BaseType; @@ -131,7 +131,8 @@ public: typename LocalVolumeTwoFormInterface<V>::derived_type, RangeType, SourceType, - FieldType> AccumulateFunctor; + FieldType> + AccumulateFunctor; local_volume_twoforms_.emplace_back( new AccumulateFunctor(grid_view(), local_volume_twoform.as_imp(), range_, source_, *where)); BaseType::add(*local_volume_twoforms_.back(), where); @@ -177,7 +178,8 @@ class MatrixOperatorBase public SystemAssembler<RangeSpaceImp, GridViewImp, SourceSpaceImp> { typedef OperatorInterface<internal::MatrixOperatorBaseTraits<MatrixImp, RangeSpaceImp, GridViewImp, SourceSpaceImp, - FieldImp, pt>> BaseOperatorType; + FieldImp, pt>> + BaseOperatorType; typedef SystemAssembler<RangeSpaceImp, GridViewImp, SourceSpaceImp> BaseAssemblerType; typedef MatrixOperatorBase<MatrixImp, RangeSpaceImp, GridViewImp, SourceSpaceImp, FieldImp, pt> ThisType; @@ -301,7 +303,8 @@ public: { typedef internal::LocalVolumeTwoFormWrapper<ThisType, typename LocalVolumeTwoFormInterface<V>::derived_type, - MatrixType> WrapperType; + MatrixType> + WrapperType; this->codim0_functors_.emplace_back(new WrapperType( this->test_space_, this->ansatz_space_, where, local_volume_twoform.as_imp(), matrix_.access())); } @@ -313,7 +316,8 @@ public: { typedef internal::LocalCouplingTwoFormWrapper<ThisType, typename LocalCouplingTwoFormInterface<C>::derived_type, - MatrixType> WrapperType; + MatrixType> + WrapperType; this->codim1_functors_.emplace_back(new WrapperType( this->test_space_, this->ansatz_space_, where, local_coupling_twoform.as_imp(), matrix_.access())); } @@ -325,7 +329,8 @@ public: { typedef internal::LocalBoundaryTwoFormWrapper<ThisType, typename LocalBoundaryTwoFormInterface<B>::derived_type, - MatrixType> WrapperType; + MatrixType> + WrapperType; this->codim1_functors_.emplace_back(new WrapperType( this->test_space_, this->ansatz_space_, where, local_boundary_twoform.as_imp(), matrix_.access())); } @@ -461,7 +466,8 @@ public: typedef LocalOperatorApplicator<GridViewType, typename LocalOperatorInterface<L>::derived_type, SourceType, - RangeType> Applicator; + RangeType> + Applicator; local_operators_codim_0.emplace_back(new Applicator(grid_view(), local_operator.as_imp(), source_, range_, *where)); BaseType::add(*local_operators_codim_0.back(), where); } // ... add(...) @@ -474,7 +480,8 @@ public: typedef LocalCouplingOperatorApplicator<GridViewType, typename LocalCouplingOperatorInterface<T>::derived_type, SourceType, - RangeType> Applicator; + RangeType> + Applicator; local_operators_codim_1.emplace_back(new Applicator(grid_view(), local_operator.as_imp(), source_, range_, *where)); BaseType::add(*local_operators_codim_1.back(), where); } // ... add(...) @@ -487,7 +494,8 @@ public: typedef LocalBoundaryOperatorApplicator<GridViewType, typename LocalBoundaryOperatorInterface<T>::derived_type, SourceType, - RangeType> Applicator; + RangeType> + Applicator; local_operators_codim_1.emplace_back(new Applicator(grid_view(), local_operator.as_imp(), source_, range_, *where)); BaseType::add(*local_operators_codim_1.back(), where); } // ... add(...) diff --git a/dune/gdt/operators/darcy.hh b/dune/gdt/operators/darcy.hh index 2920a838acd252d6f4b25fb778f70539d3fd4883..04f9e215601b61edf81b9f16a0d4624d201f84d6 100644 --- a/dune/gdt/operators/darcy.hh +++ b/dune/gdt/operators/darcy.hh @@ -151,7 +151,7 @@ private: const auto integration_element = entity.geometry().integrationElement(xx); const ValueType function_value = local_function->evaluate(xx); const auto source_gradient = local_source->jacobian(xx); - const auto basis_value = basis.evaluate(xx); + const auto basis_value = basis.evaluate(xx); for (size_t ii = 0; ii < basis.size(); ++ii) { const size_t global_ii = range.space().mapper().mapToGlobal(entity, ii); rhs.add_to_entry(global_ii, @@ -186,8 +186,8 @@ private: static_assert(RtSpaceInterface<T, dimDomain, 1>::polOrder == 0, "Untested!"); const auto& rtn0_space = range.space(); auto& range_vector = range.vector(); - const auto infinity = std::numeric_limits<FieldType>::infinity(); - for (size_t ii = 0; ii < range_vector.size(); ++ii) + const auto infinity = std::numeric_limits<FieldType>::infinity(); + for (size_t ii = 0; ii < range_vector.size(); ++ii) range_vector[ii] = infinity; // walk the grid const auto entity_it_end = grid_view_.template end<0>(); @@ -206,7 +206,7 @@ private: const auto& intersection = *intersection_it; if (intersection.neighbor() && !intersection.boundary()) { const auto neighbor_ptr = intersection.outside(); - const auto& neighbor = *neighbor_ptr; + const auto& neighbor = *neighbor_ptr; if (grid_view_.indexSet().index(entity) < grid_view_.indexSet().index(neighbor)) { const auto local_function_neighbor = function_.local_function(neighbor); const auto local_source_neighbor = source.local_function(neighbor); @@ -216,7 +216,7 @@ private: FieldType lhs = 0; FieldType rhs = 0; const size_t integrand_order = local_function->order(); - const auto& quadrature = QuadratureRules<DomainFieldType, dimDomain - 1>::rule( + const auto& quadrature = QuadratureRules<DomainFieldType, dimDomain - 1>::rule( intersection.type(), boost::numeric_cast<int>(integrand_order)); const auto quadrature_it_end = quadrature.end(); for (auto quadrature_it = quadrature.begin(); quadrature_it != quadrature_it_end; ++quadrature_it) { @@ -255,7 +255,7 @@ private: FieldType lhs = 0; FieldType rhs = 0; const size_t integrand_order = local_function->order(); - const auto& quadrature = QuadratureRules<DomainFieldType, dimDomain - 1>::rule( + const auto& quadrature = QuadratureRules<DomainFieldType, dimDomain - 1>::rule( intersection.type(), boost::numeric_cast<int>(integrand_order)); const auto quadrature_it_end = quadrature.end(); for (auto quadrature_it = quadrature.begin(); quadrature_it != quadrature_it_end; ++quadrature_it) { @@ -304,7 +304,8 @@ private: template <class G, class F> -std::unique_ptr<DarcyOperator<G, F>> make_darcy(const G& grid_view, const F& function) +std::unique_ptr<DarcyOperator<G, F>> +make_darcy(const G& grid_view, const F& function) { return std::unique_ptr<DarcyOperator<G, F>>(new DarcyOperator<G, F>(grid_view, function)); } diff --git a/dune/gdt/operators/elliptic-ipdg.hh b/dune/gdt/operators/elliptic-ipdg.hh index b05e18632da75b7b44fa7af7979a719e38e5ba9c..d4fc8cd45fe9250527c122eeca72f3ce7687a4d6 100644 --- a/dune/gdt/operators/elliptic-ipdg.hh +++ b/dune/gdt/operators/elliptic-ipdg.hh @@ -29,7 +29,7 @@ namespace GDT { template <class DiffusionFactorType, typename DiffusionTensorType, // may be void class RangeSpace, LocalEllipticIpdgIntegrands::Method method = LocalEllipticIpdgIntegrands::default_method, - class Matrix = typename Stuff::LA::Container<typename RangeSpace::RangeFieldType>::MatrixType, + class Matrix = typename Stuff::LA::Container<typename RangeSpace::RangeFieldType>::MatrixType, class GridView = typename RangeSpace::GridViewType, class SourceSpace = RangeSpace, class Field = typename RangeSpace::RangeFieldType> class EllipticIpdgMatrixOperator @@ -39,7 +39,8 @@ class EllipticIpdgMatrixOperator typedef LocalVolumeIntegralOperator<LocalEllipticIntegrand<DiffusionFactorType, DiffusionTensorType>> LocalVolumeOperatorType; typedef LocalCouplingIntegralOperator<LocalEllipticIpdgIntegrands::Inner<DiffusionFactorType, DiffusionTensorType, - method>> LocalCouplingOperatorType; + method>> + LocalCouplingOperatorType; typedef LocalBoundaryIntegralOperator<LocalEllipticIpdgIntegrands::BoundaryLHS<DiffusionFactorType, DiffusionTensorType, method>> LocalBoundaryOperatorType; diff --git a/dune/gdt/operators/elliptic.hh b/dune/gdt/operators/elliptic.hh index 8a61a219860dd8f0f2dd8c3b0b70d2fe72bf5acc..7ec24cd9da39bc3ab77139261268ed1bd8312d05 100644 --- a/dune/gdt/operators/elliptic.hh +++ b/dune/gdt/operators/elliptic.hh @@ -544,7 +544,8 @@ class EllipticOperator Field>> { typedef OperatorInterface<internal::EllipticOperatorTraits<DiffusionFactorType, DiffusionTensorType, GridViewType, - Field>> BaseType; + Field>> + BaseType; typedef LocalEllipticIntegrand<DiffusionFactorType, DiffusionTensorType> LocalIntegrandType; public: diff --git a/dune/gdt/operators/fluxreconstruction.hh b/dune/gdt/operators/fluxreconstruction.hh index 4ef6bd9bc461749193d72800f62b9aa30f397a7b..395616837b06b84570cd0c41aeaaf85a3c061284 100644 --- a/dune/gdt/operators/fluxreconstruction.hh +++ b/dune/gdt/operators/fluxreconstruction.hh @@ -69,7 +69,7 @@ public: const auto& rtn0_space = range.space(); auto& range_vector = range.vector(); const FieldType infinity = std::numeric_limits<FieldType>::infinity(); - for (size_t ii = 0; ii < range_vector.size(); ++ii) + for (size_t ii = 0; ii < range_vector.size(); ++ii) range_vector[ii] = infinity; const LocalEllipticIpdgIntegrands::Inner<DiffusionFactorType, DiffusionTensorType> inner_evaluation( diffusion_factor_, diffusion_tensor_); @@ -103,7 +103,7 @@ public: const auto& intersection = *intersection_it; if (intersection.neighbor() && !intersection.boundary()) { const auto neighbor_ptr = intersection.outside(); - const auto& neighbor = *neighbor_ptr; + const auto& neighbor = *neighbor_ptr; if (grid_view_.indexSet().index(entity) < grid_view_.indexSet().index(neighbor)) { const auto local_diffusion_factor_neighbor = diffusion_factor_.local_function(neighbor); const auto local_diffusion_tensor_neighbor = diffusion_tensor_.local_function(neighbor); @@ -254,7 +254,7 @@ public: const auto& rtn0_space = range.space(); auto& range_vector = range.vector(); const FieldType infinity = std::numeric_limits<FieldType>::infinity(); - for (size_t ii = 0; ii < range_vector.size(); ++ii) + for (size_t ii = 0; ii < range_vector.size(); ++ii) range_vector[ii] = infinity; const LocalEllipticIpdgIntegrands::Inner<LocalizableFunctionType> inner_evaluation(diffusion_); const LocalEllipticIpdgIntegrands::BoundaryLHS<LocalizableFunctionType> boundary_evaluation(diffusion_); @@ -285,7 +285,7 @@ public: const auto& intersection = *intersection_it; if (intersection.neighbor() && !intersection.boundary()) { const auto neighbor_ptr = intersection.outside(); - const auto& neighbor = *neighbor_ptr; + const auto& neighbor = *neighbor_ptr; if (grid_view_.indexSet().index(entity) < grid_view_.indexSet().index(neighbor)) { const auto local_diffusion_neighbor = diffusion_.local_function(neighbor); const auto local_source_neighbor = source.local_function(neighbor); diff --git a/dune/gdt/operators/fv.hh b/dune/gdt/operators/fv.hh index 8372bbac552c66140b41f06c058ca5348b85b31e..fda2c1e2a0099ee563396b1d0bbf13145f1000ae 100644 --- a/dune/gdt/operators/fv.hh +++ b/dune/gdt/operators/fv.hh @@ -86,7 +86,8 @@ class AdvectionLaxFriedrichsOperatorTraits : public AdvectionTraitsBase<Analytic public: typedef LocalizableFunctionImp LocalizableFunctionType; typedef AdvectionLaxFriedrichsOperator<AnalyticalFluxImp, BoundaryValueFunctionImp, LocalizableFunctionImp, - slope_limiter> derived_type; + slope_limiter> + derived_type; }; // class AdvectionLaxFriedrichsOperatorTraits @@ -264,7 +265,8 @@ struct AdvectionOperatorApplier 1, // polOrder RangeFieldType, dimRange, - dimRangeCols> DGSpaceType; + dimRangeCols> + DGSpaceType; typedef DiscreteFunction<DGSpaceType, typename SourceType::VectorType> ReconstructedDiscreteFunctionType; const auto dg_space = DSC::make_unique<DGSpaceType>(range.space().grid_view()); const auto reconstruction = DSC::make_unique<ReconstructedDiscreteFunctionType>(*dg_space, "reconstructed"); @@ -272,23 +274,21 @@ struct AdvectionOperatorApplier ReconstructedDiscreteFunctionType, typename BoundaryValueFunctionType::ExpressionFunctionType, MatrixType, - slope_limiter> reconstruction_operator(source, - *reconstruction, - eigenvectors, - eigenvectors_inverse, - *current_boundary_values); + slope_limiter> + reconstruction_operator( + source, *reconstruction, eigenvectors, eigenvectors_inverse, *current_boundary_values); reconstruction_operator.apply(); AdvectionLocalizableDefault<AnalyticalFluxType, NumericalCouplingFluxType, NumericalBoundaryFluxType, typename BoundaryValueFunctionType::ExpressionFunctionType, ReconstructedDiscreteFunctionType, - RangeType> localizable_operator(analytical_flux, - *current_boundary_values, - *reconstruction, - range, - std::forward<LocalOperatorArgTypes>( - local_operator_args)...); + RangeType> + localizable_operator(analytical_flux, + *current_boundary_values, + *reconstruction, + range, + std::forward<LocalOperatorArgTypes>(local_operator_args)...); localizable_operator.apply(); } else { AdvectionLocalizableDefault<AnalyticalFluxType, @@ -296,12 +296,12 @@ struct AdvectionOperatorApplier NumericalBoundaryFluxType, typename BoundaryValueFunctionType::ExpressionFunctionType, SourceType, - RangeType> localizable_operator(analytical_flux, - *current_boundary_values, - source, - range, - std::forward<LocalOperatorArgTypes>( - local_operator_args)...); + RangeType> + localizable_operator(analytical_flux, + *current_boundary_values, + source, + range, + std::forward<LocalOperatorArgTypes>(local_operator_args)...); localizable_operator.apply(); } } @@ -320,7 +320,8 @@ class AdvectionLaxFriedrichsOperator { public: typedef internal::AdvectionLaxFriedrichsOperatorTraits<AnalyticalFluxImp, BoundaryValueFunctionImp, - LocalizableFunctionImp, slope_limiter> Traits; + LocalizableFunctionImp, slope_limiter> + Traits; typedef typename Traits::AnalyticalFluxType AnalyticalFluxType; typedef typename Traits::LocalizableFunctionType LocalizableFunctionType; typedef typename Traits::BoundaryValueFunctionType BoundaryValueFunctionType; @@ -335,18 +336,20 @@ private: public: typedef typename Dune::GDT::LocalLaxFriedrichsNumericalCouplingFlux<AnalyticalFluxType, LocalizableFunctionType, - dimDomain> NumericalCouplingFluxType; + dimDomain> + NumericalCouplingFluxType; typedef typename Dune::GDT:: LocalLaxFriedrichsDirichletNumericalBoundaryFlux<AnalyticalFluxType, typename BoundaryValueFunctionType::TimeIndependentFunctionType, - LocalizableFunctionType, dimDomain> NumericalBoundaryFluxType; + LocalizableFunctionType, dimDomain> + NumericalBoundaryFluxType; AdvectionLaxFriedrichsOperator(const AnalyticalFluxType& analytical_flux, const BoundaryValueFunctionType& boundary_values, const LocalizableFunctionType& dx, - const double dt, const bool is_linear = false, + const double dt, const bool is_linear = false, const bool use_linear_reconstruction = false, const bool use_local_laxfriedrichs_flux = false, - const bool entity_geometries_equal = false) + const bool entity_geometries_equal = false) : analytical_flux_(analytical_flux) , boundary_values_(boundary_values) , dx_(dx) @@ -398,7 +401,7 @@ private: // TODO: 0 boundary by default, so no need to specify boundary conditions for periodic grid views -template <class AnalyticalFluxImp, class BoundaryValueFunctionImp, SlopeLimiters slope_limiter > +template <class AnalyticalFluxImp, class BoundaryValueFunctionImp, SlopeLimiters slope_limiter> class AdvectionGodunovOperator : public Dune::GDT::OperatorInterface<internal::AdvectionGodunovOperatorTraits<AnalyticalFluxImp, BoundaryValueFunctionImp, @@ -418,11 +421,12 @@ private: typedef typename Dune::Stuff::Common::FieldMatrix<RangeFieldType, dimRange, dimRange> MatrixType; public: - typedef - typename Dune::GDT::LocalGodunovNumericalCouplingFlux<AnalyticalFluxType, dimDomain> NumericalCouplingFluxType; - typedef typename Dune::GDT::LocalGodunovNumericalBoundaryFlux<AnalyticalFluxType, typename BoundaryValueFunctionType:: - TimeIndependentFunctionType, - dimDomain> NumericalBoundaryFluxType; + typedef typename Dune::GDT::LocalGodunovNumericalCouplingFlux<AnalyticalFluxType, dimDomain> + NumericalCouplingFluxType; + typedef typename Dune::GDT:: + LocalGodunovNumericalBoundaryFlux<AnalyticalFluxType, + typename BoundaryValueFunctionType::TimeIndependentFunctionType, dimDomain> + NumericalBoundaryFluxType; AdvectionGodunovOperator(const AnalyticalFluxType& analytical_flux, const BoundaryValueFunctionType& boundary_values, const bool is_linear = false, const bool use_linear_reconstruction = false) diff --git a/dune/gdt/operators/l2.hh b/dune/gdt/operators/l2.hh index 16041f41d2d20d1356e3b3dac5e60eee0cc0b756..ee4007760f35fc0394156e1b06f3519dc5052a23 100644 --- a/dune/gdt/operators/l2.hh +++ b/dune/gdt/operators/l2.hh @@ -40,7 +40,8 @@ class L2LocalizableProduct typedef WeightedL2LocalizableProduct<Stuff::Functions::Constant<typename Stuff::Grid::Entity<GridView>::type, typename GridView::ctype, GridView::dimension, Field, 1>, - GridView, Range, Source, Field> BaseType; + GridView, Range, Source, Field> + BaseType; // The following tag and the two ctors are unfortunately necessary. There should have been two ctors, // L2LocalizableProduct(Args&& ...args) @@ -141,7 +142,8 @@ class L2MatrixOperator FunctionProvider; typedef WeightedL2MatrixOperator<Stuff::Functions::Constant<typename Stuff::Grid::Entity<GridView>::type, typename GridView::ctype, GridView::dimension, Field, 1>, - RangeSpace, Matrix, GridView, SourceSpace, Field> BaseType; + RangeSpace, Matrix, GridView, SourceSpace, Field> + BaseType; // We suffer from the same problem as in L2LocalizableProduct, see above for an explanation. template <bool anything> diff --git a/dune/gdt/operators/laplace.hh b/dune/gdt/operators/laplace.hh index 053eb379f09deb2fe24f230b323578ae83120831..b0a6bb5817ab50c453681f2a27ed3627f1e5c21a 100644 --- a/dune/gdt/operators/laplace.hh +++ b/dune/gdt/operators/laplace.hh @@ -40,7 +40,8 @@ class LaplaceLocalizableProduct typedef EllipticLocalizableProduct<Stuff::Functions::Constant<typename Stuff::Grid::Entity<GridView>::type, typename GridView::ctype, GridView::dimension, Field, 1>, - void, GridView, Range, Source, Field> BaseType; + void, GridView, Range, Source, Field> + BaseType; // We suffer from the same problem as in L2LocalizableProduct, see there for an explanation. template <bool anything> @@ -130,7 +131,8 @@ class LaplaceMatrixOperator FunctionProvider; typedef EllipticMatrixOperator<Stuff::Functions::Constant<typename Stuff::Grid::Entity<GridView>::type, typename GridView::ctype, GridView::dimension, Field, 1>, - void, RangeSpace, Matrix, GridView, SourceSpace, Field> BaseType; + void, RangeSpace, Matrix, GridView, SourceSpace, Field> + BaseType; // We suffer from the same problem as in L2LocalizableProduct, see there for an explanation. template <bool anything> diff --git a/dune/gdt/operators/oswaldinterpolation.hh b/dune/gdt/operators/oswaldinterpolation.hh index f514d5c605edc5f8a244e34ec61a1297302326fc..4d05b5feec32cb754a87ec0ec890eada22d59555 100644 --- a/dune/gdt/operators/oswaldinterpolation.hh +++ b/dune/gdt/operators/oswaldinterpolation.hh @@ -101,7 +101,7 @@ private: for (auto entity_it = grid_view_.template begin<0>(); entity_it != entity_it_end; ++entity_it) { const auto& entity = *entity_it; const size_t num_vertices = boost::numeric_cast<size_t>(entity.template count<dimDomain>()); - const auto basis = source.space().base_function_set(entity); + const auto basis = source.space().base_function_set(entity); if (basis.size() != num_vertices) DUNE_THROW(Dune::Stuff::Exceptions::internal_error, "basis.size() = " << basis.size()); @@ -136,7 +136,7 @@ private: DUNE_THROW(Dune::Stuff::Exceptions::internal_error, ss.str()); } // now we know that the local DoF index of this vertex is ii - const size_t global_DoF_index = source.space().mapper().mapToGlobal(entity, local_DoF_index); + const size_t global_DoF_index = source.space().mapper().mapToGlobal(entity, local_DoF_index); global_DoF_id_to_global_vertex_id_map[global_DoF_index] = global_vertex_id; global_vertex_id_to_global_DoF_id_map[global_vertex_id].insert(global_DoF_index); } // loop over all vertices @@ -154,9 +154,9 @@ private: // now, we need to find the entity's vertex this intersection's corner point equals to, so we // loop over all vertices of the entity for (size_t local_vertex_id = 0; local_vertex_id < num_vertices; ++local_vertex_id) { - const auto vertex_ptr = entity.template subEntity<dimDomain>(boost::numeric_cast<int>(local_vertex_id)); + const auto vertex_ptr = entity.template subEntity<dimDomain>(boost::numeric_cast<int>(local_vertex_id)); const auto global_vertex_id = grid_view_.indexSet().index(*vertex_ptr); - const auto vertex = vertex_ptr->geometry().center(); + const auto vertex = vertex_ptr->geometry().center(); if (Stuff::Common::FloatCmp::eq(global_intersection_corner, vertex)) boundary_vertices.insert(global_vertex_id); } // loop over all vertices of the entity diff --git a/dune/gdt/operators/weighted-l2.hh b/dune/gdt/operators/weighted-l2.hh index 521c68b07db01dbd3cd009b7ff71c190e73db9b3..3ef45019e3063243edcbd916ff671a8caf95df69 100644 --- a/dune/gdt/operators/weighted-l2.hh +++ b/dune/gdt/operators/weighted-l2.hh @@ -28,7 +28,7 @@ namespace GDT { // //////////////////////////// // template <class WeightFunctionType, class GridView, class Range, class Source = Range, - class Field = typename Range::RangeFieldType> + class Field = typename Range::RangeFieldType> class WeightedL2LocalizableProduct : public LocalizableProductBase<GridView, Range, Source, Field> { typedef LocalizableProductBase<GridView, Range, Source, Field> BaseType; diff --git a/dune/gdt/playground/local/integrands/OS2014.hh b/dune/gdt/playground/local/integrands/OS2014.hh index bb97122ccd7e03774cbb48a7a322f51ed8ed1d3b..e2c5187132a8d951567bd0dc6efd0bc4d579f535 100644 --- a/dune/gdt/playground/local/integrands/OS2014.hh +++ b/dune/gdt/playground/local/integrands/OS2014.hh @@ -62,11 +62,13 @@ class LocalDiffusiveFluxEstimateStarOS2014IntegrandTraits public: typedef LocalDiffusiveFluxEstimateStarOS2014Integrand<DiffusionFactorType, DiffusionFactorHatType, - DiffusionTensorType, DiffusiveFluxType> derived_type; + DiffusionTensorType, DiffusiveFluxType> + derived_type; typedef std::tuple<std::shared_ptr<typename DiffusionFactorType::LocalfunctionType>, std::shared_ptr<typename DiffusionFactorHatType::LocalfunctionType>, std::shared_ptr<typename DiffusionTensorType::LocalfunctionType>, - std::shared_ptr<typename DiffusiveFluxType::LocalfunctionType>> LocalfunctionTupleType; + std::shared_ptr<typename DiffusiveFluxType::LocalfunctionType>> + LocalfunctionTupleType; typedef typename DiffusionFactorType::EntityType EntityType; typedef typename DiffusionFactorType::DomainFieldType DomainFieldType; static const size_t dimDomain = DiffusionFactorType::dimDomain; @@ -90,11 +92,13 @@ class LocalDiffusiveFluxEstimateStarOS2014Integrand DiffusionFactorHatType, DiffusionTensorType, DiffusiveFluxType>, - 2> BaseType; + 2> + BaseType; public: typedef internal::LocalDiffusiveFluxEstimateStarOS2014IntegrandTraits<DiffusionFactorType, DiffusionFactorHatType, - DiffusionTensorType, DiffusiveFluxType> Traits; + DiffusionTensorType, DiffusiveFluxType> + Traits; using typename BaseType::LocalfunctionTupleType; using typename BaseType::EntityType; using typename BaseType::DomainFieldType; @@ -128,7 +132,7 @@ public: const auto local_diffusion_factor = std::get<0>(localFuncs); const auto local_diffusion_factor_hat = std::get<1>(localFuncs); const auto local_diffusion_tensor = std::get<2>(localFuncs); - const auto local_diffusive_flux = std::get<3>(localFuncs); + const auto local_diffusive_flux = std::get<3>(localFuncs); return order(*local_diffusion_factor, *local_diffusion_factor_hat, *local_diffusion_tensor, @@ -169,7 +173,7 @@ public: const auto local_diffusion_factor = std::get<0>(localFuncs); const auto local_diffusion_factor_hat = std::get<1>(localFuncs); const auto local_diffusion_tensor = std::get<2>(localFuncs); - const auto local_diffusive_flux = std::get<3>(localFuncs); + const auto local_diffusive_flux = std::get<3>(localFuncs); evaluate(*local_diffusion_factor, *local_diffusion_factor_hat, *local_diffusion_tensor, diff --git a/dune/gdt/playground/spaces/block.hh b/dune/gdt/playground/spaces/block.hh index e5fdd67af99c4b6a790c72cc3328f704f436e70c..746cc5e3a1df6fb460f01d4dd973520168123bf7 100644 --- a/dune/gdt/playground/spaces/block.hh +++ b/dune/gdt/playground/spaces/block.hh @@ -72,7 +72,8 @@ class BlockSpace : public SpaceInterface<internal::BlockSpaceTraits<LocalSpaceIm LocalSpaceImp::dimRange, LocalSpaceImp::dimRangeCols> { typedef SpaceInterface<internal::BlockSpaceTraits<LocalSpaceImp>, LocalSpaceImp::dimDomain, LocalSpaceImp::dimRange, - LocalSpaceImp::dimRangeCols> BaseType; + LocalSpaceImp::dimRangeCols> + BaseType; typedef BlockSpace<LocalSpaceImp> ThisType; public: diff --git a/dune/gdt/playground/spaces/cg/dune-fem-localfunctions-wrapper.hh b/dune/gdt/playground/spaces/cg/dune-fem-localfunctions-wrapper.hh index 50110c755ac4838df1be06db541c48c5d79293dc..6f54168f1ad508297c5c64394d0fa6357bd1c144 100644 --- a/dune/gdt/playground/spaces/cg/dune-fem-localfunctions-wrapper.hh +++ b/dune/gdt/playground/spaces/cg/dune-fem-localfunctions-wrapper.hh @@ -86,14 +86,15 @@ public: private: typedef Dune::FemLocalFunctions::BaseFunctionSetMap<GridPartType, FiniteElementType, Dune::FemLocalFunctions::NoTransformation, - Dune::FemLocalFunctions::SimpleStorage, polOrder, - polOrder> BaseFunctionSetMapType; + Dune::FemLocalFunctions::SimpleStorage, polOrder, polOrder> + BaseFunctionSetMapType; public: typedef Dune::FemLocalFunctions::DiscreteFunctionSpace<BaseFunctionSetMapType> BackendType; typedef Mapper::FemDofWrapper<typename BackendType::MapperType> MapperType; typedef BaseFunctionSet::DuneFemLocalfunctionsWrapper<BaseFunctionSetMapType, DomainFieldType, dimDomain, - RangeFieldType, rangeDim, rangeDimCols> BaseFunctionSetType; + RangeFieldType, rangeDim, rangeDimCols> + BaseFunctionSetType; typedef typename BaseFunctionSetType::EntityType EntityType; static const Stuff::Grid::ChoosePartView part_view_type = Stuff::Grid::ChoosePartView::part; static const bool needs_grid_view = false; @@ -112,7 +113,8 @@ class DuneFemLocalfunctionsCgSpaceWrapper<GridPartImp, polynomialOrder, RangeFie GridPartImp::dimension, RangeFieldImp, 1, 1> { typedef CgSpaceInterface<DuneFemLocalfunctionsCgSpaceWrapperTraits<GridPartImp, polynomialOrder, RangeFieldImp, 1, 1>, - GridPartImp::dimension, RangeFieldImp, 1, 1> BaseType; + GridPartImp::dimension, RangeFieldImp, 1, 1> + BaseType; typedef DuneFemLocalfunctionsCgSpaceWrapper<GridPartImp, polynomialOrder, RangeFieldImp, 1, 1> ThisType; public: @@ -166,7 +168,7 @@ public: gridView_ = other.gridView_; baseFunctionSetMap_ = other.baseFunctionSetMap_; backend_ = other.backend_; - mapper_ = other.mapper_; + mapper_ = other.mapper_; tmp_global_indices_.resize(mapper_->maxNumDofs()); } return *this; diff --git a/dune/gdt/playground/spaces/dg/dune-fem-localfunctions-wrapper.hh b/dune/gdt/playground/spaces/dg/dune-fem-localfunctions-wrapper.hh index b4388f4d6f19fdd826a2827d26988584279f468d..073068a39375bcf1304c7aaa39b29f0f0a38dce9 100644 --- a/dune/gdt/playground/spaces/dg/dune-fem-localfunctions-wrapper.hh +++ b/dune/gdt/playground/spaces/dg/dune-fem-localfunctions-wrapper.hh @@ -83,14 +83,15 @@ public: private: typedef Dune::FemLocalFunctions::BaseFunctionSetMap<GridPartType, FiniteElementType, Dune::FemLocalFunctions::NoTransformation, - Dune::FemLocalFunctions::SimpleStorage, polOrder, - polOrder> BaseFunctionSetMapType; + Dune::FemLocalFunctions::SimpleStorage, polOrder, polOrder> + BaseFunctionSetMapType; public: typedef Dune::FemLocalFunctions::DiscreteFunctionSpace<BaseFunctionSetMapType> BackendType; typedef Mapper::FemDofWrapper<typename BackendType::MapperType> MapperType; typedef BaseFunctionSet::DuneFemLocalfunctionsWrapper<BaseFunctionSetMapType, DomainFieldType, dimDomain, - RangeFieldType, rangeDim, rangeDimCols> BaseFunctionSetType; + RangeFieldType, rangeDim, rangeDimCols> + BaseFunctionSetType; typedef typename BaseFunctionSetType::EntityType EntityType; static const Stuff::Grid::ChoosePartView part_view_type = Stuff::Grid::ChoosePartView::part; static const bool needs_grid_view = false; @@ -109,7 +110,8 @@ class DuneFemLocalfunctionsDgSpaceWrapper<GridPartImp, polynomialOrder, RangeFie typename GridPartImp::dimension, 1, 1> { typedef SpaceInterface<DuneFemLocalfunctionsDgSpaceWrapperTraits<GridPartImp, polynomialOrder, RangeFieldImp, 1, 1>, - typename GridPartImp::dimension, 1, 1> BaseType; + typename GridPartImp::dimension, 1, 1> + BaseType; typedef DuneFemLocalfunctionsDgSpaceWrapper<GridPartImp, polynomialOrder, RangeFieldImp, 1, 1> ThisType; public: diff --git a/dune/gdt/playground/spaces/dg/dune-pdelab-wrapper.hh b/dune/gdt/playground/spaces/dg/dune-pdelab-wrapper.hh index 030c56eb277bde84bf5aa443ba549e86c51f7cd2..4547e764dd6f5522b1ff2f39659d450ba38e5e2e 100644 --- a/dune/gdt/playground/spaces/dg/dune-pdelab-wrapper.hh +++ b/dune/gdt/playground/spaces/dg/dune-pdelab-wrapper.hh @@ -94,7 +94,7 @@ private: }; typedef typename GridViewType::Grid GridType; static const bool single_geom_ = Dune::Capabilities::hasSingleGeometryType<GridType>::v; - static const bool simplicial_ = (Dune::Capabilities::hasSingleGeometryType<GridType>::topologyId + static const bool simplicial_ = (Dune::Capabilities::hasSingleGeometryType<GridType>::topologyId == GenericGeometry::SimplexTopology<dimDomain>::type::id); static const bool cubic_ = (Dune::Capabilities::hasSingleGeometryType<GridType>::topologyId == GenericGeometry::CubeTopology<dimDomain>::type::id); @@ -106,7 +106,8 @@ public: typedef DunePdelabDgMapperWrapper<BackendType> MapperType; typedef typename GridViewType::template Codim<0>::Entity EntityType; typedef BaseFunctionSet::DunePdelabWrapper<BackendType, EntityType, DomainFieldType, dimDomain, RangeFieldType, - rangeDim, rangeDimCols> BaseFunctionSetType; + rangeDim, rangeDimCols> + BaseFunctionSetType; static const Stuff::Grid::ChoosePartView part_view_type = Stuff::Grid::ChoosePartView::view; static const bool needs_grid_view = true; typedef CommunicationChooser<GridViewType> CommunicationChooserType; @@ -155,7 +156,8 @@ class DunePdelabDgSpaceWrapper<GridViewImp, polynomialOrder, RangeFieldImp, 1, 1 { typedef DunePdelabDgSpaceWrapper<GridViewImp, polynomialOrder, RangeFieldImp, 1, 1> ThisType; typedef DgSpaceInterface<internal::DunePdelabDgSpaceWrapperTraits<GridViewImp, polynomialOrder, RangeFieldImp, 1, 1>, - GridViewImp::dimension, 1, 1> BaseType; + GridViewImp::dimension, 1, 1> + BaseType; public: using typename BaseType::Traits; @@ -271,11 +273,13 @@ class DunePdelabDgProductSpaceWrapper<GridViewImp, polynomialOrder, RangeFieldIm typedef typename Dune::GDT::SpaceInterface<internal::DunePdelabDgProductSpaceWrapperTraits<GridViewImp, polynomialOrder, RangeFieldImp, rangeDim, 1>, - GridViewImp::dimension, rangeDim, 1> BaseType; + GridViewImp::dimension, rangeDim, 1> + BaseType; public: - typedef typename internal::DunePdelabDgProductSpaceWrapperTraits<GridViewImp, polynomialOrder, RangeFieldImp, - rangeDim, 1> Traits; + typedef + typename internal::DunePdelabDgProductSpaceWrapperTraits<GridViewImp, polynomialOrder, RangeFieldImp, rangeDim, 1> + Traits; using typename BaseType::GridViewType; using typename BaseType::EntityType; using typename BaseType::BaseFunctionSetType; diff --git a/dune/gdt/playground/spaces/mapper/dune-pdelab-wrapper.hh b/dune/gdt/playground/spaces/mapper/dune-pdelab-wrapper.hh index c083ec35d07ab1900972bb59d6ac42babef1b3e2..d64389b45246a4374db8609b2dd4844ea780586a 100644 --- a/dune/gdt/playground/spaces/mapper/dune-pdelab-wrapper.hh +++ b/dune/gdt/playground/spaces/mapper/dune-pdelab-wrapper.hh @@ -134,9 +134,9 @@ public: if (ret.size() < factor_mapper_num_dofs) ret.resize(factor_mapper_num_dofs); const auto factor_mapper_size_times_factor_index = factor_mapper_.size() * factor_index; - const auto factor_mapper_global_indices = factor_mapper_.globalIndices(entity); + const auto factor_mapper_global_indices = factor_mapper_.globalIndices(entity); for (size_t jj = 0; jj < factor_mapper_num_dofs; ++jj) - ret[jj] = factor_mapper_global_indices[jj] + factor_mapper_size_times_factor_index; + ret[jj] = factor_mapper_global_indices[jj] + factor_mapper_size_times_factor_index; } // ... globalIndices(...) size_t mapToGlobal(const size_t factor_index, const EntityType& entity, const size_t& local_index_in_factor) const diff --git a/dune/gdt/playground/timestepper/rosenbrock.hh b/dune/gdt/playground/timestepper/rosenbrock.hh index 1cbb40b215894ac9114695b48599d613b459dd61..ff7c43c5f6d67e007b75e5e3a963d96aad4d01aa 100644 --- a/dune/gdt/playground/timestepper/rosenbrock.hh +++ b/dune/gdt/playground/timestepper/rosenbrock.hh @@ -169,7 +169,7 @@ struct RosenbrockButcherArrayProvider<RangeFieldType, TimeFieldType, RosenbrockT * \todo Implement concept of jacobian/time derivative of operator and finish implementation of this method. */ template <class OperatorImp, class DiscreteFunctionImp, class SolverImp, class TimeFieldImp = double, - RosenbrockTimeStepperMethods method = RosenbrockTimeStepperMethods::GRK4T> + RosenbrockTimeStepperMethods method = RosenbrockTimeStepperMethods::GRK4T> class RosenbrockTimeStepper : public TimeStepperInterface<DiscreteFunctionImp, TimeFieldImp> { typedef TimeStepperInterface<DiscreteFunctionImp, TimeFieldImp> BaseType; @@ -279,7 +279,7 @@ public: for (size_t ii = 0; ii < Gamma.rows(); ++ii) { if (DSC::FloatCmp::ne(gamma, Gamma_[ii])) gamma_ii_equal_for_all_i_ = false; - d_[ii] = 0.0; + d_[ii] = 0.0; for (size_t jj = 0; jj <= ii; ++jj) d_[ii] += Gamma[ii][jj]; } diff --git a/dune/gdt/prolongations/l2.hh b/dune/gdt/prolongations/l2.hh index bdbcf43167148f4c358c5a0399aaca64e4f7f4ca..573d153780c7b24e8022d00fba1773a4cb75a1a2 100644 --- a/dune/gdt/prolongations/l2.hh +++ b/dune/gdt/prolongations/l2.hh @@ -204,8 +204,9 @@ prolong_l2(const GridViewType& grid_view, const ConstDiscreteFunction<SS, SV>& s } template <class SS, class SV, class RS, class RV> -void prolong_l2(const ConstDiscreteFunction<SS, SV>& source, DiscreteFunction<RS, RV>& range, - const size_t over_integrate = 0) +void +prolong_l2(const ConstDiscreteFunction<SS, SV>& source, DiscreteFunction<RS, RV>& range, + const size_t over_integrate = 0) { make_l2_prolongation_operator(range.space().grid_view(), over_integrate)->apply(source, range); } diff --git a/dune/gdt/prolongations/lagrange.hh b/dune/gdt/prolongations/lagrange.hh index 44cdb8ba46141c50efc693c78e55bef55e79f3d0..c29c90a9be0e457eaefaa61651ad58dbd495a3d0 100644 --- a/dune/gdt/prolongations/lagrange.hh +++ b/dune/gdt/prolongations/lagrange.hh @@ -194,7 +194,8 @@ prolong_lagrange(const GridViewType& grid_view, const ConstDiscreteFunction<SS, } template <class SS, class SV, class RS, class RV> -void prolong_lagrange(const ConstDiscreteFunction<SS, SV>& source, DiscreteFunction<RS, RV>& range) +void +prolong_lagrange(const ConstDiscreteFunction<SS, SV>& source, DiscreteFunction<RS, RV>& range) { make_lagrange_prolongation_operator(range.space().grid_view())->apply(source, range); } diff --git a/dune/gdt/spaces/basefunctionset/dune-fem-localfunctions-wrapper.hh b/dune/gdt/spaces/basefunctionset/dune-fem-localfunctions-wrapper.hh index 6dbff8ed75e555aa1a1c4b9f778122f4962ec3a5..099f7aa302e10e1cc47d8c54d53f7ccdfe522d91 100644 --- a/dune/gdt/spaces/basefunctionset/dune-fem-localfunctions-wrapper.hh +++ b/dune/gdt/spaces/basefunctionset/dune-fem-localfunctions-wrapper.hh @@ -38,7 +38,8 @@ class DuneFemLocalfunctionsWrapperTraits { public: typedef DuneFemLocalfunctionsWrapper<BaseFunctionSetMapImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, - rangeDimCols> derived_type; + rangeDimCols> + derived_type; typedef typename BaseFunctionSetMapImp::BaseFunctionSetType BackendType; typedef typename BackendType::EntityType EntityType; }; @@ -56,13 +57,15 @@ class DuneFemLocalfunctionsWrapper<BaseFunctionSetMapImp, DomainFieldImp, domain { typedef BaseFunctionSetInterface<internal::DuneFemLocalfunctionsWrapperTraits<BaseFunctionSetMapImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1>, - DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> BaseType; + DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> + BaseType; typedef DuneFemLocalfunctionsWrapper<BaseFunctionSetMapImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> ThisType; public: typedef internal::DuneFemLocalfunctionsWrapperTraits<BaseFunctionSetMapImp, DomainFieldImp, domainDim, RangeFieldImp, - rangeDim, 1> Traits; + rangeDim, 1> + Traits; typedef typename Traits::BackendType BackendType; typedef typename Traits::EntityType EntityType; diff --git a/dune/gdt/spaces/basefunctionset/dune-fem-wrapper.hh b/dune/gdt/spaces/basefunctionset/dune-fem-wrapper.hh index c0a0cb01e017467ab0dd8b624e3b8b25d6f96f78..f33f450e594b6392207a78f3567dbb5ed6c12d5c 100644 --- a/dune/gdt/spaces/basefunctionset/dune-fem-wrapper.hh +++ b/dune/gdt/spaces/basefunctionset/dune-fem-wrapper.hh @@ -48,7 +48,8 @@ class DuneFemWrapperTraits { public: typedef DuneFemWrapper<ShapeFunctionSetImp, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, - rangeDimCols> derived_type; + rangeDimCols> + derived_type; typedef typename Dune::Fem::DefaultBasisFunctionSet<EntityImp, ShapeFunctionSetImp> BackendType; typedef EntityImp EntityType; }; @@ -68,11 +69,13 @@ class DuneFemWrapper<ShapeFunctionSetImp, EntityImp, DomainFieldImp, domainDim, ThisType; typedef BaseFunctionSetInterface<internal::DuneFemWrapperTraits<ShapeFunctionSetImp, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1>, - DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> BaseType; + DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> + BaseType; public: typedef internal::DuneFemWrapperTraits<ShapeFunctionSetImp, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, - rangeDim, 1> Traits; + rangeDim, 1> + Traits; typedef typename Traits::BackendType BackendType; typedef typename BaseType::EntityType EntityType; typedef typename BaseType::DomainType DomainType; diff --git a/dune/gdt/spaces/basefunctionset/dune-pdelab-wrapper.hh b/dune/gdt/spaces/basefunctionset/dune-pdelab-wrapper.hh index bbbc4f555d52ba8743d3a9e5d9e6ea9c9a7403dd..a482343056ba07681bb55b8e9d0edda26b590f5b 100644 --- a/dune/gdt/spaces/basefunctionset/dune-pdelab-wrapper.hh +++ b/dune/gdt/spaces/basefunctionset/dune-pdelab-wrapper.hh @@ -84,7 +84,8 @@ class PiolaTransformedDunePdelabWrapperTraits public: typedef PiolaTransformedDunePdelabWrapper<PdelabSpaceImp, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, - rangeDim> derived_type; + rangeDim> + derived_type; private: typedef PDELab::LocalFunctionSpace<PdelabSpaceImp, PDELab::TrialSpaceTag> PdelabLFSType; @@ -113,7 +114,8 @@ class DunePdelabWrapper<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, R typedef DunePdelabWrapper<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, 1, 1> ThisType; typedef BaseFunctionSetInterface<internal::DunePdelabWrapperTraits<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, 1, 1>, - DomainFieldImp, domainDim, RangeFieldImp, 1, 1> BaseType; + DomainFieldImp, domainDim, RangeFieldImp, 1, 1> + BaseType; public: typedef internal::DunePdelabWrapperTraits<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, 1, 1> @@ -140,7 +142,7 @@ public: backend_ = std::unique_ptr<BackendType>(new BackendType(FESwitchType::basis(lfs_->finiteElement()))); } // DunePdelabWrapper(...) - DunePdelabWrapper(ThisType&& source) = default; + DunePdelabWrapper(ThisType&& source) = default; DunePdelabWrapper(const ThisType& /*other*/) = delete; ThisType& operator=(const ThisType& /*other*/) = delete; @@ -198,11 +200,13 @@ class DunePdelabWrapper<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, R typedef DunePdelabWrapper<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> ThisType; typedef BaseFunctionSetInterface<internal::DunePdelabWrapperTraits<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1>, - DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> BaseType; + DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> + BaseType; public: typedef internal::DunePdelabWrapperTraits<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, - rangeDim, 1> Traits; + rangeDim, 1> + Traits; typedef typename Traits::BackendType BackendType; typedef typename Traits::EntityType EntityType; @@ -227,7 +231,7 @@ public: backend_ = std::unique_ptr<BackendType>(new BackendType(FESwitchType::basis(lfs_->finiteElement()))); } // DunePdelabWrapper(...) - DunePdelabWrapper(ThisType&& source) = default; + DunePdelabWrapper(ThisType&& source) = default; DunePdelabWrapper(const ThisType& /*other*/) = delete; ThisType& operator=(const ThisType& /*other*/) = delete; @@ -302,15 +306,18 @@ class PiolaTransformedDunePdelabWrapper<PdelabSpaceType, EntityImp, DomainFieldI DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> { typedef PiolaTransformedDunePdelabWrapper<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, - rangeDim, 1> ThisType; + rangeDim, 1> + ThisType; typedef BaseFunctionSetInterface<internal::PiolaTransformedDunePdelabWrapperTraits<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim>, - DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> BaseType; + DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> + BaseType; public: typedef internal::PiolaTransformedDunePdelabWrapperTraits<PdelabSpaceType, EntityImp, DomainFieldImp, domainDim, - RangeFieldImp, rangeDim> Traits; + RangeFieldImp, rangeDim> + Traits; typedef typename Traits::BackendType BackendType; typedef typename Traits::EntityType EntityType; diff --git a/dune/gdt/spaces/basefunctionset/fv.hh b/dune/gdt/spaces/basefunctionset/fv.hh index cba7d21e088494fd9f3bb55dbc5058167542110b..9695760e6ca416129bc0440e25d67bc7062c0be1 100644 --- a/dune/gdt/spaces/basefunctionset/fv.hh +++ b/dune/gdt/spaces/basefunctionset/fv.hh @@ -52,7 +52,8 @@ class FiniteVolume<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, 1, 1> typedef FiniteVolume<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, 1, 1> ThisType; typedef BaseFunctionSetInterface<internal::FiniteVolumeTraits<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, 1, 1>, - DomainFieldImp, domainDim, RangeFieldImp, 1, 1> BaseType; + DomainFieldImp, domainDim, RangeFieldImp, 1, 1> + BaseType; public: typedef internal::FiniteVolumeTraits<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, 1, 1> Traits; @@ -120,7 +121,8 @@ class FiniteVolume<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim typedef FiniteVolume<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> ThisType; typedef BaseFunctionSetInterface<internal::FiniteVolumeTraits<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1>, - DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> BaseType; + DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> + BaseType; public: typedef internal::FiniteVolumeTraits<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, 1> Traits; diff --git a/dune/gdt/spaces/basefunctionset/product.hh b/dune/gdt/spaces/basefunctionset/product.hh index ba054be57b952901e8ea717dd803b39566c02876..a22fb4b74c491135a7d1d7be3e5509eca55ed367 100644 --- a/dune/gdt/spaces/basefunctionset/product.hh +++ b/dune/gdt/spaces/basefunctionset/product.hh @@ -97,12 +97,12 @@ struct DynamicTupleGetter { const auto factor_ret = std::get<I>(tuple).evaluate(xx); const auto num_basis_funcs_in_factor = factor_ret.size(); - const auto dimRangeFactor = factor_ret[0].size(); + const auto dimRangeFactor = factor_ret[0].size(); for (size_t basis_func = 0; basis_func < num_basis_funcs_in_factor; ++basis_func) { const auto& basis_func_ret = factor_ret[basis_func]; assert(basis_func_ret.size() == dimRangeFactor); ret[first_basis_func_index + basis_func] = RangeType(0); - for (size_t jj = 0; jj < dimRangeFactor; ++jj) + for (size_t jj = 0; jj < dimRangeFactor; ++jj) ret[first_basis_func_index + basis_func][first_range_index + jj] = basis_func_ret[jj]; } DynamicTupleGetter<I + 1>::evaluate( @@ -124,12 +124,12 @@ struct DynamicTupleGetter { const auto factor_ret = std::get<I>(tuple).jacobian(xx); const auto num_basis_funcs_in_factor = factor_ret.size(); - const auto dimRangeFactor = factor_ret[0].size(); + const auto dimRangeFactor = factor_ret[0].size(); for (size_t basis_func = 0; basis_func < num_basis_funcs_in_factor; ++basis_func) { const auto& basis_func_ret = factor_ret[basis_func]; assert(basis_func_ret.size() == dimRangeFactor); ret[first_basis_func_index + basis_func] = JacobianRangeType(0); - for (size_t jj = 0; jj < dimRangeFactor; ++jj) + for (size_t jj = 0; jj < dimRangeFactor; ++jj) ret[first_basis_func_index + basis_func][first_range_index + jj] = basis_func_ret[jj]; } DynamicTupleGetter<I + 1>::jacobian( @@ -168,7 +168,8 @@ class ProductDefault std::tuple_element<0, std::tuple<BaseFunctionSetImps...>>::type::dimDomain, typename std::tuple_element<0, std::tuple<BaseFunctionSetImps...>>::type:: RangeFieldType, - internal::SumDimRange<BaseFunctionSetImps...>::dimRange, 1> BaseType; + internal::SumDimRange<BaseFunctionSetImps...>::dimRange, 1> + BaseType; public: typedef internal::ProductDefaultTraits<BaseFunctionSetImps...> Traits; diff --git a/dune/gdt/spaces/cg/dune-fem-wrapper.hh b/dune/gdt/spaces/cg/dune-fem-wrapper.hh index 90ff09ee8cba395b7043551ebb69c22de7cf8e60..5118ba79be1b2aeedfd05cc8e81916410c9e92a3 100644 --- a/dune/gdt/spaces/cg/dune-fem-wrapper.hh +++ b/dune/gdt/spaces/cg/dune-fem-wrapper.hh @@ -69,7 +69,8 @@ public: typedef Mapper::FemDofWrapper<typename BackendType::BlockMapperType, BackendType::Traits::localBlockSize> MapperType; typedef typename GridPartType::template Codim<0>::EntityType EntityType; typedef BaseFunctionSet::DuneFemWrapper<typename BackendType::ShapeFunctionSetType, EntityType, DomainFieldType, - dimDomain, RangeFieldType, rangeDim, rangeDimCols> BaseFunctionSetType; + dimDomain, RangeFieldType, rangeDim, rangeDimCols> + BaseFunctionSetType; static const Stuff::Grid::ChoosePartView part_view_type = Stuff::Grid::ChoosePartView::part; static const bool needs_grid_view = false; typedef CommunicationChooser<GridViewType, false> CommunicationChooserType; @@ -84,7 +85,8 @@ class DuneFemCgSpaceWrapper<GridPartImp, polynomialOrder, RangeFieldImp, r, 1> GridPartImp::dimension, r, 1> { typedef CgSpaceInterface<DuneFemCgSpaceWrapperTraits<GridPartImp, polynomialOrder, RangeFieldImp, r, 1>, - GridPartImp::dimension, r, 1> BaseType; + GridPartImp::dimension, r, 1> + BaseType; typedef DuneFemCgSpaceWrapper<GridPartImp, polynomialOrder, RangeFieldImp, r, 1> ThisType; public: @@ -120,7 +122,7 @@ public: { } - DuneFemCgSpaceWrapper(const ThisType& other) = default; + DuneFemCgSpaceWrapper(const ThisType& other) = default; explicit DuneFemCgSpaceWrapper(ThisType&& source) = default; ThisType& operator=(const ThisType& other) = delete; diff --git a/dune/gdt/spaces/cg/dune-pdelab-wrapper.hh b/dune/gdt/spaces/cg/dune-pdelab-wrapper.hh index d88c2fabe3e9849f9a7dab1cccb3d3cd917f101d..c97d439d9dd0474ee556e69e04c60ae980d228b6 100644 --- a/dune/gdt/spaces/cg/dune-pdelab-wrapper.hh +++ b/dune/gdt/spaces/cg/dune-pdelab-wrapper.hh @@ -88,7 +88,7 @@ private: }; typedef typename GridViewType::Grid GridType; static const bool single_geom_ = Dune::Capabilities::hasSingleGeometryType<GridType>::v; - static const bool simplicial_ = (Dune::Capabilities::hasSingleGeometryType<GridType>::topologyId + static const bool simplicial_ = (Dune::Capabilities::hasSingleGeometryType<GridType>::topologyId == GenericGeometry::SimplexTopology<dimDomain>::type::id); static const bool cubic_ = (Dune::Capabilities::hasSingleGeometryType<GridType>::topologyId == GenericGeometry::CubeTopology<dimDomain>::type::id); @@ -100,7 +100,8 @@ public: typedef DunePdelabCgMapperWrapper<BackendType, rangeDim> MapperType; typedef typename GridViewType::template Codim<0>::Entity EntityType; typedef BaseFunctionSet::DunePdelabWrapper<BackendType, EntityType, DomainFieldType, dimDomain, RangeFieldType, - rangeDim, rangeDimCols> BaseFunctionSetType; + rangeDim, rangeDimCols> + BaseFunctionSetType; static const Stuff::Grid::ChoosePartView part_view_type = Stuff::Grid::ChoosePartView::view; static const bool needs_grid_view = true; @@ -147,7 +148,8 @@ class DunePdelabCgSpaceWrapper<GridViewImp, polynomialOrder, RangeFieldImp, 1, 1 GridViewImp::dimension, 1, 1> { typedef CgSpaceInterface<DunePdelabCgSpaceWrapperTraits<GridViewImp, polynomialOrder, RangeFieldImp, 1, 1>, - GridViewImp::dimension, 1, 1> BaseType; + GridViewImp::dimension, 1, 1> + BaseType; typedef DunePdelabCgSpaceWrapper<GridViewImp, polynomialOrder, RangeFieldImp, 1, 1> ThisType; public: @@ -281,10 +283,12 @@ class DunePdelabCgSpaceWrapper<GridViewImp, polynomialOrder, RangeFieldImp, rang GridViewImp::dimension, rangeDim, 1> { typedef CgSpaceInterface<DunePdelabCgSpaceWrapperTraits<GridViewImp, polynomialOrder, RangeFieldImp, rangeDim, 1>, - GridViewImp::dimension, rangeDim, 1> BaseType; + GridViewImp::dimension, rangeDim, 1> + BaseType; typedef ProductSpaceInterface<DunePdelabCgSpaceWrapperTraits<GridViewImp, polynomialOrder, RangeFieldImp, rangeDim, 1>, - GridViewImp::dimension, rangeDim, 1> ProductInterfaceType; + GridViewImp::dimension, rangeDim, 1> + ProductInterfaceType; typedef DunePdelabCgSpaceWrapper<GridViewImp, polynomialOrder, RangeFieldImp, rangeDim, 1> ThisType; public: diff --git a/dune/gdt/spaces/cg/interface.hh b/dune/gdt/spaces/cg/interface.hh index c3ff4b09a3ece75a91e815d0df7db50fc7093829..2664897dcdf8206e9bb079309379fd941b7c7a87 100644 --- a/dune/gdt/spaces/cg/interface.hh +++ b/dune/gdt/spaces/cg/interface.hh @@ -92,7 +92,7 @@ public: typedef typename BaseType::BaseFunctionSetType::RangeType RangeType; std::vector<RangeType> tmp_basis_values(basis.size(), RangeType(0)); const auto& reference_element = ReferenceElements<DomainFieldType, dimDomain>::general(entity.type()); - const auto num_vertices = reference_element.size(dimDomain); + const auto num_vertices = reference_element.size(dimDomain); assert(num_vertices >= 0); assert(boost::numeric_cast<size_t>(num_vertices) == basis.size() && "This should not happen with polOrder 1!"); // prepare return vector @@ -128,7 +128,7 @@ public: DUNE_THROW(NotImplemented, "Does not work for higher dimensions"); // check assert(this->grid_view().indexSet().contains(entity)); - if(!entity.hasBoundaryIntersections()) + if (!entity.hasBoundaryIntersections()) return std::set<size_t>(); // prepare std::set<size_t> localDirichletDofs; @@ -203,7 +203,7 @@ public: // calculate by using lagrange grid {x = \sum_{j=0}^d \lambda_j a_j | \sum_j lambda_j = 1}, where a_j are the // vertices of the entity and \lambda_j \in {\frac{m}{polOrder} | m = 0, ... , polOrder} std::vector<double> possible_coefficients(polOrder < 1 ? 0 : polOrder - 1); - for (int m = 0; m < polOrder; ++m) + for (int m = 0; m < polOrder; ++m) possible_coefficients[m] = m / polOrder; std::set<std::vector<double>> possible_coefficient_vectors; possible_convex_combination_coefficients( diff --git a/dune/gdt/spaces/dg/dune-fem-wrapper.hh b/dune/gdt/spaces/dg/dune-fem-wrapper.hh index 6ddf1fbb42fd3f4df377cca90afb1e77a778705b..4440493c1debfb8a4254c558eb899737bb3b4f43 100644 --- a/dune/gdt/spaces/dg/dune-fem-wrapper.hh +++ b/dune/gdt/spaces/dg/dune-fem-wrapper.hh @@ -70,7 +70,8 @@ public: typedef Mapper::FemDofWrapper<typename BackendType::BlockMapperType, BackendType::Traits::localBlockSize> MapperType; typedef typename GridPartType::template Codim<0>::EntityType EntityType; typedef BaseFunctionSet::DuneFemWrapper<typename BackendType::ShapeFunctionSetType, EntityType, DomainFieldType, - dimDomain, RangeFieldType, rangeDim, rangeDimCols> BaseFunctionSetType; + dimDomain, RangeFieldType, rangeDim, rangeDimCols> + BaseFunctionSetType; static const Stuff::Grid::ChoosePartView part_view_type = Stuff::Grid::ChoosePartView::part; static const bool needs_grid_view = false; typedef CommunicationChooser<GridViewType, false> CommunicationChooserType; @@ -89,7 +90,8 @@ class DuneFemDgSpaceWrapper<GridPartImp, polynomialOrder, RangeFieldImp, 1, 1> { typedef DuneFemDgSpaceWrapper<GridPartImp, polynomialOrder, RangeFieldImp, 1, 1> ThisType; typedef DgSpaceInterface<internal::DuneFemDgSpaceWrapperTraits<GridPartImp, polynomialOrder, RangeFieldImp, 1, 1>, - GridPartImp::dimension, 1, 1> BaseType; + GridPartImp::dimension, 1, 1> + BaseType; public: using typename BaseType::Traits; diff --git a/dune/gdt/spaces/fv/default.hh b/dune/gdt/spaces/fv/default.hh index ccbbb8f4f6bb8bc0cbd125fdcd580637b8b6fc5f..d1d32a2363e5208634e7d82661145c75c82e5b96 100644 --- a/dune/gdt/spaces/fv/default.hh +++ b/dune/gdt/spaces/fv/default.hh @@ -49,8 +49,8 @@ public: typedef RangeFieldImp RangeFieldType; typedef FvMapper<GridViewType, rangeDim, rangeDimCols> MapperType; typedef BaseFunctionSet::FiniteVolume<typename GridViewType::template Codim<0>::Entity, typename GridViewType::ctype, - GridViewType::dimension, RangeFieldType, rangeDim, - rangeDimCols> BaseFunctionSetType; + GridViewType::dimension, RangeFieldType, rangeDim, rangeDimCols> + BaseFunctionSetType; static const Stuff::Grid::ChoosePartView part_view_type = Stuff::Grid::ChoosePartView::view; static const bool needs_grid_view = true; typedef CommunicationChooser<GridViewType> CommunicationChooserType; @@ -68,7 +68,8 @@ class FvSpace<GridViewImp, RangeFieldImp, rangeDim, 1> { typedef FvSpace<GridViewImp, RangeFieldImp, rangeDim, 1> ThisType; typedef FvSpaceInterface<internal::FvSpaceTraits<GridViewImp, RangeFieldImp, rangeDim, 1>, GridViewImp::dimension, - rangeDim, 1> BaseType; + rangeDim, 1> + BaseType; public: typedef typename internal::FvSpaceTraits<GridViewImp, RangeFieldImp, rangeDim, 1> Traits; @@ -138,13 +139,15 @@ private: template <class R, size_t r, size_t rC, class GV> -FvSpace<GV, R, r, rC> make_fv_space(const GV& grid_view) +FvSpace<GV, R, r, rC> +make_fv_space(const GV& grid_view) { return FvSpace<GV, R, r, rC>(grid_view); } template <class R, size_t r, class GV> -FvSpace<GV, R, r, 1> make_fv_space(const GV& grid_view) +FvSpace<GV, R, r, 1> +make_fv_space(const GV& grid_view) { return FvSpace<GV, R, r, 1>(grid_view); } diff --git a/dune/gdt/spaces/fv/product.hh b/dune/gdt/spaces/fv/product.hh index 87a4094876611ee105b0d0315b96f81876fec413..e4a2d0c52d66fdd02685ac5f1b565fbfc5dcc065 100644 --- a/dune/gdt/spaces/fv/product.hh +++ b/dune/gdt/spaces/fv/product.hh @@ -59,7 +59,8 @@ class FvProductSpace<GridViewImp, RangeFieldImp, rangeDim, 1> { typedef FvProductSpace<GridViewImp, RangeFieldImp, rangeDim, 1> ThisType; typedef Dune::GDT::FvSpaceInterface<internal::FvProductSpaceTraits<GridViewImp, RangeFieldImp, rangeDim, 1>, - GridViewImp::dimension, rangeDim, 1> BaseType; + GridViewImp::dimension, rangeDim, 1> + BaseType; typedef FvSpace<GridViewImp, RangeFieldImp, rangeDim, 1> FvSpaceFVSpaceType; public: @@ -80,7 +81,7 @@ public: } FvProductSpace(const ThisType& other) = default; - FvProductSpace(ThisType&& source) = default; + FvProductSpace(ThisType&& source) = default; ThisType& operator=(const ThisType& other) = delete; diff --git a/dune/gdt/spaces/mapper/dune-pdelab-wrapper.hh b/dune/gdt/spaces/mapper/dune-pdelab-wrapper.hh index de2982a4d81c118c489a205b2ec1e748174af1b9..e5e913d11b6a8bc9d6c95727527e7b149764c093 100644 --- a/dune/gdt/spaces/mapper/dune-pdelab-wrapper.hh +++ b/dune/gdt/spaces/mapper/dune-pdelab-wrapper.hh @@ -84,7 +84,7 @@ public: { const auto& grid_view = backend_.gridView(); const auto it_end = grid_view.template end<0>(); - std::size_t count = 0; + std::size_t count = 0; for (auto it = grid_view.template begin<0>(); it != it_end; ++it) { const auto& entity = *it; lfs_.bind(entity); @@ -128,7 +128,7 @@ public: ret.resize(numLocalDofs); // compute for (size_t ii = 0; ii < numLocalDofs; ++ii) - ret[ii] = mapToGlobal(entity, ii); + ret[ii] = mapToGlobal(entity, ii); } // ... globalIndices(...) using InterfaceType::globalIndices; diff --git a/dune/gdt/spaces/mapper/fv.hh b/dune/gdt/spaces/mapper/fv.hh index 834f552bf7daacde40991abec9b3b73056518f62..2b7b70aac7edb820f3283ce565a3939659775e16 100644 --- a/dune/gdt/spaces/mapper/fv.hh +++ b/dune/gdt/spaces/mapper/fv.hh @@ -108,7 +108,7 @@ public: ret.resize(dimRange); const size_t base = dimRange * backend_.index(entity); for (size_t ii = 0; ii < dimRange; ++ii) - ret[ii] = base + ii; + ret[ii] = base + ii; } // ... globalIndices(...) using InterfaceType::globalIndices; diff --git a/dune/gdt/spaces/mapper/product.hh b/dune/gdt/spaces/mapper/product.hh index fce8bb88b754ed6847f13909b5086dfc83323c11..1a2397cab99987ca098f04b664f3a791a27edd18 100644 --- a/dune/gdt/spaces/mapper/product.hh +++ b/dune/gdt/spaces/mapper/product.hh @@ -198,7 +198,7 @@ public: if (ret.size() != num_dofs_entity) ret.resize(num_dofs_entity); for (size_t ii = 0; ii < num_dofs_entity; ++ii) - ret[ii] = mapToGlobal(factor_index, entity, ii); + ret[ii] = mapToGlobal(factor_index, entity, ii); } size_t mapToGlobal(const size_t factor_index, const EntityType& entity, const size_t& local_index_in_factor) const @@ -247,7 +247,7 @@ public: size_t maxNumDofs() const { size_t max_num_dofs = 0; - const auto it_end = grid_view_.template end<0>(); + const auto it_end = grid_view_.template end<0>(); for (auto it = grid_view_.template begin<0>(); it != it_end; ++it) { const auto& entity = *it; if (max_num_dofs < numDofs(entity)) @@ -262,7 +262,7 @@ public: if (ret.size() != num_dofs_entity) ret.resize(num_dofs_entity); for (size_t ii = 0; ii < num_dofs_entity; ++ii) - ret[ii] = mapToGlobal(entity, ii); + ret[ii] = mapToGlobal(entity, ii); } // ... globalIndices(...) using BaseType::globalIndices; diff --git a/dune/gdt/spaces/product.hh b/dune/gdt/spaces/product.hh index b4d01b127f8085074e5efef2aa246f4551e24b2b..716e7c92793aa54d3b550f8cfd76becc75400bac 100644 --- a/dune/gdt/spaces/product.hh +++ b/dune/gdt/spaces/product.hh @@ -32,7 +32,8 @@ namespace internal { template <class T> -constexpr T staticMax(T a, T b) +constexpr T +staticMax(T a, T b) { return a > b ? a : b; } @@ -102,7 +103,8 @@ class DefaultProductSpace typedef DefaultProductSpace<SpaceImps...> ThisType; typedef Dune::GDT::SpaceInterface<internal::DefaultProductSpaceTraits<SpaceImps...>, std::tuple_element<0, std::tuple<SpaceImps...>>::type::dimDomain, - GDT::BaseFunctionSet::internal::SumDimRange<SpaceImps...>::dimRange, 1> BaseType; + GDT::BaseFunctionSet::internal::SumDimRange<SpaceImps...>::dimRange, 1> + BaseType; public: typedef typename internal::DefaultProductSpaceTraits<SpaceImps...> Traits; diff --git a/dune/gdt/spaces/rt/dune-pdelab-wrapper.hh b/dune/gdt/spaces/rt/dune-pdelab-wrapper.hh index cd249499dd91784e1092a388d7ff3d7cc85d836c..7323f1de3beb34934a40f4c6d75125097e2fdcda 100644 --- a/dune/gdt/spaces/rt/dune-pdelab-wrapper.hh +++ b/dune/gdt/spaces/rt/dune-pdelab-wrapper.hh @@ -81,17 +81,19 @@ private: struct FeMap<G, true, true, false> { typedef PDELab::RaviartThomasLocalFiniteElementMap<GridViewType, DomainFieldType, RangeFieldType, polOrder, - Dune::GeometryType::simplex> Type; + Dune::GeometryType::simplex> + Type; }; template <class G> struct FeMap<G, true, false, true> { typedef PDELab::RaviartThomasLocalFiniteElementMap<GridViewType, DomainFieldType, RangeFieldType, polOrder, - Dune::GeometryType::cube> Type; + Dune::GeometryType::cube> + Type; }; typedef typename GridViewType::Grid GridType; static const bool single_geom_ = Dune::Capabilities::hasSingleGeometryType<GridType>::v; - static const bool simplicial_ = (Dune::Capabilities::hasSingleGeometryType<GridType>::topologyId + static const bool simplicial_ = (Dune::Capabilities::hasSingleGeometryType<GridType>::topologyId == GenericGeometry::SimplexTopology<dimDomain>::type::id); static const bool cubic_ = (Dune::Capabilities::hasSingleGeometryType<GridType>::topologyId == GenericGeometry::CubeTopology<dimDomain>::type::id); @@ -102,8 +104,8 @@ public: typedef DunePdelabCgMapperWrapper<BackendType> MapperType; typedef typename GridViewType::template Codim<0>::Entity EntityType; typedef BaseFunctionSet::PiolaTransformedDunePdelabWrapper<BackendType, EntityType, DomainFieldType, dimDomain, - RangeFieldType, rangeDim, - rangeDimCols> BaseFunctionSetType; + RangeFieldType, rangeDim, rangeDimCols> + BaseFunctionSetType; static const Stuff::Grid::ChoosePartView part_view_type = Stuff::Grid::ChoosePartView::view; static const bool needs_grid_view = true; typedef CommunicationChooser<GridViewType> CommunicationChooserType; @@ -124,7 +126,8 @@ class DunePdelabRtSpaceWrapper<GridViewImp, 0, RangeFieldImp, rangeDim, 1> { typedef DunePdelabRtSpaceWrapper<GridViewImp, 0, RangeFieldImp, rangeDim, 1> ThisType; typedef RtSpaceInterface<internal::DunePdelabRtSpaceWrapperTraits<GridViewImp, 0, RangeFieldImp, rangeDim, 1>, - GridViewImp::dimension, rangeDim, 1> BaseType; + GridViewImp::dimension, rangeDim, 1> + BaseType; public: typedef internal::DunePdelabRtSpaceWrapperTraits<GridViewImp, 0, RangeFieldImp, rangeDim, 1> Traits; diff --git a/dune/gdt/test/hyperbolic/discretizers/fv.hh b/dune/gdt/test/hyperbolic/discretizers/fv.hh index 98d18b816f2350534dc8f45f369944206287dfc0..8761518bbacb1ccde99331b3c19babe603cbf58d 100644 --- a/dune/gdt/test/hyperbolic/discretizers/fv.hh +++ b/dune/gdt/test/hyperbolic/discretizers/fv.hh @@ -25,22 +25,24 @@ namespace Hyperbolic { template <class TestCaseType, class GridType, class RangeFieldType, size_t dimRange, size_t dimRangeCols = 1, - NumericalFluxes numerical_flux = NumericalFluxes::godunov, - TimeStepperMethods time_stepper_method = TimeStepperMethods::explicit_euler> + NumericalFluxes numerical_flux = NumericalFluxes::godunov, + TimeStepperMethods time_stepper_method = TimeStepperMethods::explicit_euler> class FvDiscretizer { public: typedef Hyperbolic::ProblemInterface<typename GridType::template Codim<0>::Entity, typename GridType::ctype, - GridType::dimension, RangeFieldType, dimRange, dimRangeCols> ProblemType; + GridType::dimension, RangeFieldType, dimRange, dimRangeCols> + ProblemType; static const constexpr ChooseDiscretizer type = ChooseDiscretizer::fv; static const constexpr NumericalFluxes numerical_flux_type = numerical_flux; static const constexpr TimeStepperMethods time_stepper_type = time_stepper_method; - typedef - typename DSG::PeriodicGridView<typename Stuff::Grid::ProviderInterface<GridType>::LevelGridViewType> GridViewType; + typedef typename DSG::PeriodicGridView<typename Stuff::Grid::ProviderInterface<GridType>::LevelGridViewType> + GridViewType; typedef FvProductSpace<GridViewType, RangeFieldType, dimRange, dimRangeCols> FVSpaceType; typedef HyperbolicFVDefaultDiscretization<TestCaseType, FVSpaceType, numerical_flux, time_stepper_method, - time_stepper_method> DiscretizationType; + time_stepper_method> + DiscretizationType; static std::string static_id() { // int() needed, otherwise we get a linker error diff --git a/dune/gdt/test/hyperbolic/eocexpectations-fv-boltzmanncheckerboard-2dyaspgrid.cxx b/dune/gdt/test/hyperbolic/eocexpectations-fv-boltzmanncheckerboard-2dyaspgrid.cxx index 8e45842cd69c3f25d320fe3ee87c0020d19ea66d..1838bf3ee03e8ea3cf2aa6f57d8226a785edf8fb 100644 --- a/dune/gdt/test/hyperbolic/eocexpectations-fv-boltzmanncheckerboard-2dyaspgrid.cxx +++ b/dune/gdt/test/hyperbolic/eocexpectations-fv-boltzmanncheckerboard-2dyaspgrid.cxx @@ -23,8 +23,8 @@ namespace Tests { template <bool anything> class HyperbolicEocExpectations<Hyperbolic::Boltzmann2DCheckerboardTestCase<Dune::YaspGrid<2>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 2, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 2, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<2> { typedef Hyperbolic::Boltzmann2DCheckerboardTestCase<Dune::YaspGrid<2>, double> TestCaseType; @@ -46,8 +46,8 @@ public: }; // HyperbolicEocExpectations template class HyperbolicEocExpectations<Hyperbolic::Boltzmann2DCheckerboardTestCase<Dune::YaspGrid<2>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 2, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 2, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler>; } // namespace Tests diff --git a/dune/gdt/test/hyperbolic/eocexpectations-fv-burgers-1dyaspgrid.cxx b/dune/gdt/test/hyperbolic/eocexpectations-fv-burgers-1dyaspgrid.cxx index 15c77aef75457b9b9b8847e3ce454a58db0d9155..48b46f7cb1a91bf5f22a8305743eec1af8a447a9 100644 --- a/dune/gdt/test/hyperbolic/eocexpectations-fv-burgers-1dyaspgrid.cxx +++ b/dune/gdt/test/hyperbolic/eocexpectations-fv-burgers-1dyaspgrid.cxx @@ -23,8 +23,8 @@ namespace Tests { template <bool anything> class HyperbolicEocExpectations<Hyperbolic::BurgersTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::BurgersTestCase<Dune::YaspGrid<1>, double, 1> TestCaseType; @@ -40,7 +40,7 @@ public: return {1.33e-02, 6.34e-03}; else EXPECT_TRUE(false) << "test results missing for t_end = " << DSC::toString(test_case.t_end()); - } else { + } else { return {1.13e-01, 6.17e-02, 2.88e-02, 1.24e-02, 4.82e-03}; } } else @@ -51,8 +51,8 @@ public: template <bool anything> class HyperbolicEocExpectations<Hyperbolic::BurgersTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::dormand_prince, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::dormand_prince, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::BurgersTestCase<Dune::YaspGrid<1>, double, 1> TestCaseType; @@ -68,7 +68,7 @@ public: return {1.33e-02, 6.33e-03}; else EXPECT_TRUE(false) << "test results missing for t_end = " << DSC::toString(test_case.t_end()); - } else { + } else { return {1.15e-01, 6.48e-02, 3.31e-02, 1.52e-02, 5.68e-03}; } } else @@ -79,8 +79,8 @@ public: template <bool anything> class HyperbolicEocExpectations<Hyperbolic::BurgersTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::laxfriedrichs, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::laxfriedrichs, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::BurgersTestCase<Dune::YaspGrid<1>, double, 1> TestCaseType; @@ -105,16 +105,16 @@ public: }; // HyperbolicEocExpectations template class HyperbolicEocExpectations<Hyperbolic::BurgersTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler>; template class HyperbolicEocExpectations<Hyperbolic::BurgersTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::dormand_prince>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::dormand_prince>; template class HyperbolicEocExpectations<Hyperbolic::BurgersTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::laxfriedrichs, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::laxfriedrichs, + TimeStepperMethods::explicit_euler>; } // namespace Tests diff --git a/dune/gdt/test/hyperbolic/eocexpectations-fv-burgers-2dyaspgrid.cxx b/dune/gdt/test/hyperbolic/eocexpectations-fv-burgers-2dyaspgrid.cxx index 3804ba75cf0887e6d6d2d303f8452d92f0a97ec0..5aa1a9b9008c1ba3ab87757264c4799ee05a092d 100644 --- a/dune/gdt/test/hyperbolic/eocexpectations-fv-burgers-2dyaspgrid.cxx +++ b/dune/gdt/test/hyperbolic/eocexpectations-fv-burgers-2dyaspgrid.cxx @@ -23,8 +23,8 @@ namespace Tests { template <bool anything> class HyperbolicEocExpectations<Hyperbolic::BurgersTestCase<Dune::YaspGrid<2>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 2, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 2, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<2> { typedef Hyperbolic::BurgersTestCase<Dune::YaspGrid<2>, double, 1> TestCaseType; @@ -39,7 +39,7 @@ public: return {3.60e-04, 1.70e-04}; else EXPECT_TRUE(false) << "test results missing for t_end = " << DSC::toString(test_case.t_end()); - } else { + } else { EXPECT_TRUE(false) << "test results missing for type: " << type; } return {}; @@ -47,8 +47,8 @@ public: }; // HyperbolicEocExpectations template class HyperbolicEocExpectations<Hyperbolic::BurgersTestCase<Dune::YaspGrid<2>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 2, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 2, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler>; } // namespace Tests diff --git a/dune/gdt/test/hyperbolic/eocexpectations-fv-shallowwater-1dyaspgrid.cxx b/dune/gdt/test/hyperbolic/eocexpectations-fv-shallowwater-1dyaspgrid.cxx index 3bfedf1ff03d0772f6ad035a5597ada68bdd1a4d..a4fc65bbedf6171912205baa6f42b32e8dfa50be 100644 --- a/dune/gdt/test/hyperbolic/eocexpectations-fv-shallowwater-1dyaspgrid.cxx +++ b/dune/gdt/test/hyperbolic/eocexpectations-fv-shallowwater-1dyaspgrid.cxx @@ -23,8 +23,8 @@ namespace Tests { template <bool anything> class HyperbolicEocExpectations<Hyperbolic::ShallowWaterTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::ShallowWaterTestCase<Dune::YaspGrid<1>, double> TestCaseType; @@ -40,7 +40,7 @@ public: return {5.03e-01, 2.31e-01}; else EXPECT_TRUE(false) << "test results missing for t_end = " << DSC::toString(test_case.t_end()); - } else { + } else { return {4.10e+00, 2.82e+00, 1.41e+00}; } } else @@ -50,8 +50,8 @@ public: }; // HyperbolicEocExpectations template class HyperbolicEocExpectations<Hyperbolic::ShallowWaterTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler>; } // namespace Tests diff --git a/dune/gdt/test/hyperbolic/eocexpectations-fv-shocktube-1dyaspgrid.cxx b/dune/gdt/test/hyperbolic/eocexpectations-fv-shocktube-1dyaspgrid.cxx index b35776c398d3ea052115c9a0f391ea810ca46bec..8dd180d89b2ada79c7c6ecb1503b85005e581e1a 100644 --- a/dune/gdt/test/hyperbolic/eocexpectations-fv-shocktube-1dyaspgrid.cxx +++ b/dune/gdt/test/hyperbolic/eocexpectations-fv-shocktube-1dyaspgrid.cxx @@ -23,8 +23,8 @@ namespace Tests { template <bool anything> class HyperbolicEocExpectations<Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>, double> TestCaseType; @@ -40,7 +40,7 @@ public: return {6.68e-03, 4.69e-03}; else EXPECT_TRUE(false) << "test results missing for t_end = " << DSC::toString(test_case.t_end()); - } else { + } else { return {6.99e-02, 4.93e-02, 3.30e-02, 2.05e-02}; } } else @@ -51,8 +51,8 @@ public: template <bool anything> class HyperbolicEocExpectations<Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::dormand_prince, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::dormand_prince, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>, double> TestCaseType; @@ -68,7 +68,7 @@ public: return {6.68e-03, 4.71e-03}; else EXPECT_TRUE(false) << "test results missing for t_end = " << DSC::toString(test_case.t_end()); - } else { + } else { return {7.05e-02, 5.04e-02, 3.47e-02, 2.32e-02}; } } else @@ -79,8 +79,8 @@ public: template <bool anything> class HyperbolicEocExpectations<Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::laxfriedrichs, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::laxfriedrichs, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>, double> TestCaseType; @@ -105,16 +105,16 @@ public: }; // HyperbolicEocExpectations template class HyperbolicEocExpectations<Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler>; template class HyperbolicEocExpectations<Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::dormand_prince>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::dormand_prince>; template class HyperbolicEocExpectations<Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::laxfriedrichs, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::laxfriedrichs, + TimeStepperMethods::explicit_euler>; } // namespace Tests diff --git a/dune/gdt/test/hyperbolic/eocexpectations-fv-sourcebeam-1dyaspgrid.cxx b/dune/gdt/test/hyperbolic/eocexpectations-fv-sourcebeam-1dyaspgrid.cxx index 6ec50cfa1e2f697f6ec8fa7e64c51f3cf6b597df..33f79b9232e116b3163c71e1e0d4998b593af983 100644 --- a/dune/gdt/test/hyperbolic/eocexpectations-fv-sourcebeam-1dyaspgrid.cxx +++ b/dune/gdt/test/hyperbolic/eocexpectations-fv-sourcebeam-1dyaspgrid.cxx @@ -23,8 +23,8 @@ namespace Tests { template <bool anything> class HyperbolicEocExpectations<Hyperbolic::SourceBeamTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::SourceBeamTestCase<Dune::YaspGrid<1>, double> TestCaseType; @@ -47,8 +47,8 @@ public: template <bool anything> class HyperbolicEocExpectations<Hyperbolic::SourceBeamTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov_with_reconstruction, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov_with_reconstruction, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::SourceBeamTestCase<Dune::YaspGrid<1>, double> TestCaseType; @@ -72,12 +72,13 @@ public: }; // HyperbolicEocExpectations template class HyperbolicEocExpectations<Hyperbolic::SourceBeamTestCase<Dune::YaspGrid<1>, double>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler>; template class HyperbolicEocExpectations<Hyperbolic::SourceBeamTestCase<Dune::YaspGrid<1>, double>, Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov_with_reconstruction, TimeStepperMethods::explicit_euler>; + NumericalFluxes::godunov_with_reconstruction, + TimeStepperMethods::explicit_euler>; } // namespace Tests diff --git a/dune/gdt/test/hyperbolic/eocexpectations-fv-transport-1dyaspgrid.cxx b/dune/gdt/test/hyperbolic/eocexpectations-fv-transport-1dyaspgrid.cxx index 3bcf851e7beb01b097a63068c4108978d10351eb..ed31f87b0166e18541dab5e4d2e25c7fdbe49d8d 100644 --- a/dune/gdt/test/hyperbolic/eocexpectations-fv-transport-1dyaspgrid.cxx +++ b/dune/gdt/test/hyperbolic/eocexpectations-fv-transport-1dyaspgrid.cxx @@ -23,8 +23,8 @@ namespace Tests { template <bool anything> class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1> TestCaseType; @@ -50,8 +50,8 @@ public: template <bool anything> class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::dormand_prince, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::dormand_prince, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1> TestCaseType; @@ -77,8 +77,8 @@ public: template <bool anything> class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::laxfriedrichs, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::laxfriedrichs, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1> TestCaseType; @@ -94,7 +94,7 @@ public: return {5.69e-02, 4.67e-02}; else EXPECT_TRUE(false) << "test results missing for t_end = " << DSC::toString(test_case.t_end()); - } else { + } else { return {3.57e-01, 3.48e-01, 3.12e-01, 2.50e-01, 1.87e-01}; } } else @@ -105,8 +105,8 @@ public: template <bool anything> class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov_with_reconstruction, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov_with_reconstruction, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<1> { typedef Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1> TestCaseType; @@ -122,7 +122,7 @@ public: return {4.75e-02, 2.81e-02}; else EXPECT_TRUE(false) << "test results missing for type: " << type; - } else { + } else { return {3.29e-01, 2.47e-01, 1.06e-01, 3.83e-02, 3.33e-02}; } } else @@ -132,20 +132,21 @@ public: }; // HyperbolicEocExpectations template class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler>; template class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov, TimeStepperMethods::dormand_prince>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::godunov, + TimeStepperMethods::dormand_prince>; template class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::laxfriedrichs, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 1, NumericalFluxes::laxfriedrichs, + TimeStepperMethods::explicit_euler>; template class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1>, Hyperbolic::ChooseDiscretizer::fv, 1, - NumericalFluxes::godunov_with_reconstruction, TimeStepperMethods::explicit_euler>; + NumericalFluxes::godunov_with_reconstruction, + TimeStepperMethods::explicit_euler>; } // namespace Tests diff --git a/dune/gdt/test/hyperbolic/eocexpectations-fv-transport-2dyaspgrid.cxx b/dune/gdt/test/hyperbolic/eocexpectations-fv-transport-2dyaspgrid.cxx index 2e5d8fc363737f1318618ce0e6b6087a28032d15..617c56d324a0d7f3b2e6d600fa63f67ae1308bee 100644 --- a/dune/gdt/test/hyperbolic/eocexpectations-fv-transport-2dyaspgrid.cxx +++ b/dune/gdt/test/hyperbolic/eocexpectations-fv-transport-2dyaspgrid.cxx @@ -23,8 +23,8 @@ namespace Tests { template <bool anything> class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 2, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 2, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<2> { typedef Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1> TestCaseType; @@ -51,8 +51,8 @@ public: template <bool anything> class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 2, - NumericalFluxes::godunov, TimeStepperMethods::dormand_prince, anything> + Hyperbolic::ChooseDiscretizer::fv, 2, NumericalFluxes::godunov, + TimeStepperMethods::dormand_prince, anything> : public internal::HyperbolicEocExpectationsBase<2> { typedef Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1> TestCaseType; @@ -79,8 +79,8 @@ public: template <bool anything> class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 2, - NumericalFluxes::laxfriedrichs, TimeStepperMethods::explicit_euler, anything> + Hyperbolic::ChooseDiscretizer::fv, 2, NumericalFluxes::laxfriedrichs, + TimeStepperMethods::explicit_euler, anything> : public internal::HyperbolicEocExpectationsBase<2> { typedef Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1> TestCaseType; @@ -106,16 +106,16 @@ public: }; // HyperbolicEocExpectations template class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 2, - NumericalFluxes::godunov, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 2, NumericalFluxes::godunov, + TimeStepperMethods::explicit_euler>; template class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 2, - NumericalFluxes::godunov, TimeStepperMethods::dormand_prince>; + Hyperbolic::ChooseDiscretizer::fv, 2, NumericalFluxes::godunov, + TimeStepperMethods::dormand_prince>; template class HyperbolicEocExpectations<Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1>, - Hyperbolic::ChooseDiscretizer::fv, 2, - NumericalFluxes::laxfriedrichs, TimeStepperMethods::explicit_euler>; + Hyperbolic::ChooseDiscretizer::fv, 2, NumericalFluxes::laxfriedrichs, + TimeStepperMethods::explicit_euler>; } // namespace Tests diff --git a/dune/gdt/test/hyperbolic/eocstudy.hh b/dune/gdt/test/hyperbolic/eocstudy.hh index d6df6c27a6e058cd382aac7414086fb8f995ca81..8ecd85d184bf2239d64cac876eff0bdac354d8e3 100644 --- a/dune/gdt/test/hyperbolic/eocstudy.hh +++ b/dune/gdt/test/hyperbolic/eocstudy.hh @@ -95,10 +95,10 @@ public: double spatial_integral = 0; // walk over all entities, solution is constant on each entity const auto& grid_view = solution_it->second.space().grid_view(); - const auto it_end = grid_view.template end<0>(); + const auto it_end = grid_view.template end<0>(); for (auto it = grid_view.template begin<0>(); it != it_end; ++it) { const auto& entity = *it; - double value = 0; + double value = 0; for (const auto& index : solution_it->second.space().mapper().globalIndices(entity)) value += std::abs(solution_it->second.vector()[index]); spatial_integral += value * entity.geometry().volume(); diff --git a/dune/gdt/test/hyperbolic/fv-discretization.hh b/dune/gdt/test/hyperbolic/fv-discretization.hh index e7b4276fdd2587b7da0190131e7335792477f4e5..c89199677594c90f76cf8c220b0fec98b550edb0 100644 --- a/dune/gdt/test/hyperbolic/fv-discretization.hh +++ b/dune/gdt/test/hyperbolic/fv-discretization.hh @@ -42,7 +42,8 @@ struct hyperbolic_FV_discretization_base : public ::testing::Test TestCaseType::dimRange, TestCaseType::dimRangeCols, numerical_flux, - time_stepper> Discretizer; + time_stepper> + Discretizer; Tests::HyperbolicEocStudy<TestCaseType, Discretizer> eoc_study(test_case, {}); Stuff::Test::check_eoc_study_for_success(eoc_study, eoc_study.run(DSC_LOG_INFO)); } // ... eoc_study() diff --git a/dune/gdt/test/hyperbolic/problems.hh b/dune/gdt/test/hyperbolic/problems.hh index 2c16694b5edddebaf52154ab57e7561f8f2272ce..26443b94d037561d3ee9775d87161e040a70bbc2 100644 --- a/dune/gdt/test/hyperbolic/problems.hh +++ b/dune/gdt/test/hyperbolic/problems.hh @@ -26,7 +26,8 @@ typedef testing::Types<Dune::GDT::Hyperbolic::Boltzmann2DCheckerboardTestCase<Du Dune::GDT::Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>>, Dune::GDT::Hyperbolic::SourceBeamTestCase<Dune::YaspGrid<1>, double, 5>, Dune::GDT::Hyperbolic::TransportTestCase<Dune::YaspGrid<1>, double, 1, 1>, - Dune::GDT::Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1, 1>> YaspGridTestCasesAll; + Dune::GDT::Hyperbolic::TransportTestCase<Dune::YaspGrid<2>, double, 1, 1>> + YaspGridTestCasesAll; typedef testing::Types<Dune::GDT::Hyperbolic::BurgersTestCase<Dune::YaspGrid<1>>, Dune::GDT::Hyperbolic::ShockTubeTestCase<Dune::YaspGrid<1>>, diff --git a/dune/gdt/test/hyperbolic/problems/2dboltzmann.hh b/dune/gdt/test/hyperbolic/problems/2dboltzmann.hh index 5b3c66ca13145c254c196a8ddc68061c5a8936d9..fcd51cb13e311898a22b825eb327942c87ed7514 100644 --- a/dune/gdt/test/hyperbolic/problems/2dboltzmann.hh +++ b/dune/gdt/test/hyperbolic/problems/2dboltzmann.hh @@ -46,18 +46,22 @@ public: using BaseType::dimRange; using typename BaseType::DummyEntityType; typedef typename Dune::Stuff::Functions::Affine<DummyEntityType, RangeFieldImp, dimRange, RangeFieldImp, dimRange, - dimDomain> FluxAffineFunctionType; + dimDomain> + FluxAffineFunctionType; typedef typename Dune::GDT::GlobalFunctionBasedAnalyticalFlux<FluxAffineFunctionType, EntityImp, DomainFieldImp, - dimDomain, RangeFieldImp, dimRange, 1> DefaultFluxType; + dimDomain, RangeFieldImp, dimRange, 1> + DefaultFluxType; typedef typename DefaultFluxType::FluxRangeType FluxRangeType; typedef typename FluxAffineFunctionType::FieldMatrixType MatrixType; using typename BaseType::DefaultInitialValueType; typedef typename DS::Functions::Affine<DummyEntityType, RangeFieldImp, dimRange, RangeFieldImp, dimRange, 1> RHSAffineFunctionType; typedef typename DS::Functions::FunctionCheckerboard<RHSAffineFunctionType, EntityImp, DomainFieldImp, dimDomain, - RangeFieldImp, dimRange, 1> RHSCheckerboardFunctionType; + RangeFieldImp, dimRange, 1> + RHSCheckerboardFunctionType; typedef typename Dune::GDT::CheckerboardBasedRhsEvaluationFlux<RHSCheckerboardFunctionType, EntityImp, DomainFieldImp, - dimDomain, RangeFieldImp, dimRange, 1> DefaultRHSType; + dimDomain, RangeFieldImp, dimRange, 1> + DefaultRHSType; typedef typename DefaultRHSType::RangeType RangeType; typedef typename DefaultRHSType::DomainType DomainType; using typename BaseType::DefaultBoundaryValueType; @@ -135,7 +139,7 @@ protected: if (l < momentOrder) { X[row][pos(l + 1, m - 1)] = 0.5 * D(l + 1, m - 1); X[row][pos(l + 1, m + 1)] = -0.5 * F(l + 1, m + 1); - Z[row][pos(l + 1, m)] = B(l + 1, m); + Z[row][pos(l + 1, m)] = B(l + 1, m); } } } @@ -235,7 +239,7 @@ public: return boundary_config; } - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; @@ -268,13 +272,13 @@ public: initial_value_config["num_elements"] = "[1 1]"; initial_value_config["variable"] = "x"; initial_value_config["values.0"] = GetData::create_initial_values(); - initial_value_config["name"] = static_id(); + initial_value_config["name"] = static_id(); config.add(initial_value_config, "initial_values"); ConfigType boundary_value_config; boundary_value_config["type"] = BoundaryValueType::static_id(); boundary_value_config["variable"] = "x"; boundary_value_config["expression"] = GetData::create_boundary_values(); - boundary_value_config["order"] = "0"; + boundary_value_config["order"] = "0"; config.add(boundary_value_config, "boundary_values"); if (sub_name.empty()) return config; @@ -387,7 +391,7 @@ protected: for (size_t l = 1; l <= momentOrder; ++l) for (size_t m = 0; m <= l; ++m) S[pos(l, m)][pos(l, m)] = -1.0 * Sigma_t; - size_t number = 7 * row + col; + size_t number = 7 * row + col; rhs_config["A." + DSC::to_string(number)] = DSC::to_string(S, precision); rhs_config["b." + DSC::to_string(number)] = DSC::to_string(q); } @@ -427,7 +431,7 @@ public: return boundary_config; } - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; @@ -458,7 +462,7 @@ public: initial_value_config["num_elements"] = "[1 1]"; initial_value_config["variable"] = "x"; initial_value_config["values.0"] = GetData::create_initial_values(); - initial_value_config["name"] = static_id(); + initial_value_config["name"] = static_id(); config.add(initial_value_config, "initial_values"); ConfigType boundary_value_config = BaseType::default_config().sub("boundary_values"); config.add(boundary_value_config, "boundary_values"); diff --git a/dune/gdt/test/hyperbolic/problems/burgers.hh b/dune/gdt/test/hyperbolic/problems/burgers.hh index c2a0a32349112644d35a825a38dbf3f9ebd966b4..4cfb87d89fac2b4b781e8ca8324938a6735dc9bf 100644 --- a/dune/gdt/test/hyperbolic/problems/burgers.hh +++ b/dune/gdt/test/hyperbolic/problems/burgers.hh @@ -74,7 +74,7 @@ public: return boundary_config; } - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; @@ -107,7 +107,7 @@ public: initial_value_config["lower_left"] = "[0.0 0.0 0.0]"; initial_value_config["upper_right"] = "[1.0 1.0 1.0]"; initial_value_config["num_elements"] = "[1 1 1]"; - initial_value_config["variable"] = "x"; + initial_value_config["variable"] = "x"; if (dimDomain == 1) initial_value_config["values"] = "sin(pi*x[0])"; else @@ -202,7 +202,8 @@ public: out << "+======================================================================+\n" << "|+====================================================================+|\n" << "|| Testcase: Burgers ||\n" - << "|+--------------------------------------------------------------------+|\n" << domainstring + << "|+--------------------------------------------------------------------+|\n" + << domainstring << "|| time = [0, " + DSC::toString(BaseType::t_end()) + "] ||\n" << "|| flux = 0.5*u[0]^2 ||\n" diff --git a/dune/gdt/test/hyperbolic/problems/default.hh b/dune/gdt/test/hyperbolic/problems/default.hh index fb8904f9355dd25013ef6dc79556279e3e4291e2..9af939e9d1e569fb0439c6a6b5c574db3047b2de 100644 --- a/dune/gdt/test/hyperbolic/problems/default.hh +++ b/dune/gdt/test/hyperbolic/problems/default.hh @@ -101,7 +101,7 @@ public: flux_config["variable"] = "u"; flux_config["expression"] = "[0 0 0]"; flux_config["order"] = "0"; - flux_config["gradient"] = "[0 0 0; 0 0 0; 0 0 0]"; + flux_config["gradient"] = "[0 0 0; 0 0 0; 0 0 0]"; config.add(flux_config, "flux"); ConfigType rhs_config; rhs_config["lower_left"] = "[0.0 0.0 0.0]"; @@ -109,19 +109,19 @@ public: rhs_config["num_elements"] = "[1 1 1]"; rhs_config["variable"] = "u"; rhs_config["values"] = "[0]"; - rhs_config["name"] = static_id(); + rhs_config["name"] = static_id(); config.add(rhs_config, "rhs"); ConfigType initial_value_config; initial_value_config["type"] = InitialValueType::static_id(); initial_value_config["variable"] = "x"; initial_value_config["expression"] = "[0 0 0]"; - initial_value_config["order"] = "0"; + initial_value_config["order"] = "0"; config.add(initial_value_config, "initial_values"); ConfigType boundary_value_config; boundary_value_config["type"] = BoundaryValueType::static_id(); boundary_value_config["variable"] = "x"; boundary_value_config["expression"] = "[0 0 0]"; - boundary_value_config["order"] = "1"; + boundary_value_config["order"] = "1"; config.add(boundary_value_config, "boundary_values"); if (sub_name.empty()) return config; @@ -132,7 +132,7 @@ public: } } // ... default_config(...) - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; diff --git a/dune/gdt/test/hyperbolic/problems/fokkerplanck/onebeam.hh b/dune/gdt/test/hyperbolic/problems/fokkerplanck/onebeam.hh index ad17533f949ee42bb7e90de6c1c4fff9da7320b6..aa7f613b396ebd7bdfe6e5fdd9e4fd8a82740313 100644 --- a/dune/gdt/test/hyperbolic/problems/fokkerplanck/onebeam.hh +++ b/dune/gdt/test/hyperbolic/problems/fokkerplanck/onebeam.hh @@ -157,7 +157,7 @@ public: return boundary_config; } - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; @@ -186,7 +186,7 @@ public: rhs_config["lower_left"] = "[0.0]"; rhs_config["upper_right"] = "[1.0]"; rhs_config["num_elements"] = "[10]"; - rhs_config["variable"] = "u"; + rhs_config["variable"] = "u"; GetData::create_rhs_values(rhs_config); rhs_config["name"] = static_id(); config.add(rhs_config, "rhs", true); @@ -194,7 +194,7 @@ public: boundary_value_config["type"] = DefaultBoundaryValueType::static_id(); boundary_value_config["variable"] = "x"; boundary_value_config["expression"] = GetData::create_boundary_values(); - boundary_value_config["order"] = "10"; + boundary_value_config["order"] = "10"; config.add(boundary_value_config, "boundary_values", true); if (sub_name.empty()) return config; diff --git a/dune/gdt/test/hyperbolic/problems/fokkerplanck/rectangularic.hh b/dune/gdt/test/hyperbolic/problems/fokkerplanck/rectangularic.hh index f4347fe593cdef23828162bebcfd0cad902edeb9..81b5151f5cd182ddf0a377ceb337aa3ae9bee092 100644 --- a/dune/gdt/test/hyperbolic/problems/fokkerplanck/rectangularic.hh +++ b/dune/gdt/test/hyperbolic/problems/fokkerplanck/rectangularic.hh @@ -191,7 +191,7 @@ public: return boundary_config; } - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; @@ -233,7 +233,7 @@ public: boundary_value_config["type"] = DefaultBoundaryValueType::static_id(); boundary_value_config["variable"] = "x"; boundary_value_config["expression"] = GetData::create_boundary_values(); - boundary_value_config["order"] = "10"; + boundary_value_config["order"] = "10"; config.add(boundary_value_config, "boundary_values", true); if (sub_name.empty()) return config; diff --git a/dune/gdt/test/hyperbolic/problems/fokkerplanck/sourcebeam.hh b/dune/gdt/test/hyperbolic/problems/fokkerplanck/sourcebeam.hh index 3d720b2aa1ac1164ba856178a8ad1cfe33cfabcb..d6cd112f8fc2aafe601e374455e9c8cecc2a580c 100644 --- a/dune/gdt/test/hyperbolic/problems/fokkerplanck/sourcebeam.hh +++ b/dune/gdt/test/hyperbolic/problems/fokkerplanck/sourcebeam.hh @@ -193,7 +193,7 @@ protected: return str; } else { const auto& basefunctions_right = basefunctions_values_at_plusone(); - std::string str = "["; + std::string str = "["; for (size_t cc = 0; cc < dimRange; ++cc) { if (cc > 0) str += " "; @@ -225,7 +225,7 @@ public: return boundary_config; } - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; @@ -261,7 +261,7 @@ public: boundary_value_config["type"] = DefaultBoundaryValueType::static_id(); boundary_value_config["variable"] = "x"; boundary_value_config["expression"] = GetData::create_boundary_values(); - boundary_value_config["order"] = "10"; + boundary_value_config["order"] = "10"; config.add(boundary_value_config, "boundary_values", true); if (sub_name.empty()) return config; diff --git a/dune/gdt/test/hyperbolic/problems/fokkerplanck/twobeams.hh b/dune/gdt/test/hyperbolic/problems/fokkerplanck/twobeams.hh index 335209578a453731a536fd802ae0ae8e36a961d1..dc5f9fcde8be02c417a3f20712063f071af5eec3 100644 --- a/dune/gdt/test/hyperbolic/problems/fokkerplanck/twobeams.hh +++ b/dune/gdt/test/hyperbolic/problems/fokkerplanck/twobeams.hh @@ -460,7 +460,7 @@ public: return boundary_config; } - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; @@ -498,7 +498,7 @@ public: ConfigType flux_config; flux_config["type"] = DefaultFluxType::static_id(); flux_config["A"] = GetData::create_flux_matrix(); - flux_config["b"] = DSC::to_string(RangeType(0)); + flux_config["b"] = DSC::to_string(RangeType(0)); config.add(flux_config, "flux"); ConfigType rhs_config; rhs_config["lower_left"] = "[0.0]"; @@ -513,13 +513,13 @@ public: initial_value_config["num_elements"] = "[1]"; initial_value_config["variable"] = "x"; initial_value_config["values.0"] = GetData::create_initial_values(); - initial_value_config["name"] = static_id(); + initial_value_config["name"] = static_id(); config.add(initial_value_config, "initial_values"); ConfigType boundary_value_config; boundary_value_config["type"] = BoundaryValueType::static_id(); boundary_value_config["variable"] = "x"; boundary_value_config["expression"] = GetData::create_boundary_values(); - boundary_value_config["order"] = "10"; + boundary_value_config["order"] = "10"; config.add(boundary_value_config, "boundary_values"); if (sub_name.empty()) return config; diff --git a/dune/gdt/test/hyperbolic/problems/fokkerplanck/twopulses.hh b/dune/gdt/test/hyperbolic/problems/fokkerplanck/twopulses.hh index 43e35ca76fc83481e48b725048f58a304063692d..c3088eabba11e696556051649cc80dc623b0a422 100644 --- a/dune/gdt/test/hyperbolic/problems/fokkerplanck/twopulses.hh +++ b/dune/gdt/test/hyperbolic/problems/fokkerplanck/twopulses.hh @@ -125,7 +125,7 @@ public: return boundary_config; } - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; @@ -160,7 +160,7 @@ public: boundary_value_config["type"] = DefaultBoundaryValueType::static_id(); boundary_value_config["variable"] = "x"; boundary_value_config["expression"] = GetData::create_boundary_values(); - boundary_value_config["order"] = "10"; + boundary_value_config["order"] = "10"; config.add(boundary_value_config, "boundary_values", true); if (sub_name.empty()) return config; diff --git a/dune/gdt/test/hyperbolic/problems/interface.hh b/dune/gdt/test/hyperbolic/problems/interface.hh index b6ff1a0beeb82673c6bd7752916ba69f421f6067..088cb287c9c455489a785ecddcef48cd0c582934 100644 --- a/dune/gdt/test/hyperbolic/problems/interface.hh +++ b/dune/gdt/test/hyperbolic/problems/interface.hh @@ -46,14 +46,17 @@ public: static const size_t dimRangeCols = rC; typedef Dune::GDT::AutonomousAnalyticalFluxInterface<EntityType, DomainFieldType, dimDomain, RangeFieldType, dimRange, - dimRangeCols> FluxType; + dimRangeCols> + FluxType; typedef Dune::GDT::RhsEvaluationFluxInterface<EntityType, DomainFieldType, dimDomain, RangeFieldType, dimRange, - dimRangeCols> RHSType; + dimRangeCols> + RHSType; typedef Dune::Stuff::LocalizableFunctionInterface<EntityType, DomainFieldType, dimDomain, RangeFieldType, dimRange, - dimRangeCols> InitialValueType; - typedef - typename Dune::Stuff::Functions::TimeDependentExpression<EntityType, DomainFieldType, dimDomain, RangeFieldType, - dimRange, dimRangeCols, double> BoundaryValueType; + dimRangeCols> + InitialValueType; + typedef typename Dune::Stuff::Functions::TimeDependentExpression<EntityType, DomainFieldType, dimDomain, + RangeFieldType, dimRange, dimRangeCols, double> + BoundaryValueType; typedef Dune::Stuff::Common::Configuration ConfigType; typedef DS::TimeDependentFunctionInterface< typename DS::LocalizableFunctionInterface<EntityType, DomainFieldType, dimDomain, RangeFieldType, dimRange, 1>> diff --git a/dune/gdt/test/hyperbolic/problems/shallowwater.hh b/dune/gdt/test/hyperbolic/problems/shallowwater.hh index 6bbb52ebd070118fe63f40af3e0d33c9c0203fea..89ff8a284ae2c51429e479a3b9ad8d5e8d8184bd 100644 --- a/dune/gdt/test/hyperbolic/problems/shallowwater.hh +++ b/dune/gdt/test/hyperbolic/problems/shallowwater.hh @@ -95,7 +95,7 @@ public: rhs_config["num_elements"] = "[1]"; rhs_config["variable"] = "u"; rhs_config["values.0"] = "[0 0]"; - rhs_config["name"] = static_id(); + rhs_config["name"] = static_id(); config.add(rhs_config, "rhs"); ConfigType initial_value_config; initial_value_config["lower_left"] = "[0.0]"; @@ -107,13 +107,13 @@ public: initial_value_config["values.2"] = "[1+((x[0]-4)^2)*((x[0]-6)^2)*exp(2-((x[0]-4)^2)-((x[0]-6)^2)) 0]"; initial_value_config["values.3"] = "[1 0]"; initial_value_config["values.4"] = "[1 0]"; - initial_value_config["order"] = "10"; + initial_value_config["order"] = "10"; config.add(initial_value_config, "initial_values"); ConfigType boundary_value_config = DefaultBoundaryValueType::default_config(); boundary_value_config["type"] = DefaultBoundaryValueType::static_id(); boundary_value_config["variable"] = "x"; boundary_value_config["expression"] = "[0 0 0]"; - boundary_value_config["order"] = "0"; + boundary_value_config["order"] = "0"; config.add(boundary_value_config, "boundary_values"); if (sub_name.empty()) return config; @@ -124,7 +124,7 @@ public: } } // ... default_config(...) - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; diff --git a/dune/gdt/test/hyperbolic/problems/sodshocktube.hh b/dune/gdt/test/hyperbolic/problems/sodshocktube.hh index a72dc69e0bb124b14ec27c90fcbfd704dcf4914d..0c5d370ac549e586bef99a7632e99f1f1d2c5ca6 100644 --- a/dune/gdt/test/hyperbolic/problems/sodshocktube.hh +++ b/dune/gdt/test/hyperbolic/problems/sodshocktube.hh @@ -173,7 +173,8 @@ class ShocktubeSolution typename DS::LocalizableFunctionInterface<EntityType, DomainFieldType, 1, RangeFieldType, 3, 1>, double> { typedef typename DS::TimeDependentFunctionInterface< - typename DS::LocalizableFunctionInterface<EntityType, DomainFieldType, 1, RangeFieldType, 3, 1>, double> BaseType; + typename DS::LocalizableFunctionInterface<EntityType, DomainFieldType, 1, RangeFieldType, 3, 1>, double> + BaseType; using typename BaseType::TimeIndependentFunctionType; typedef ShocktubeSolutionAtSpecificTime<EntityType, DomainFieldType, RangeFieldType> SolutionAtSpecificTimeType; @@ -277,7 +278,7 @@ public: rhs_config["num_elements"] = "[1]"; rhs_config["variable"] = "u"; rhs_config["values.0"] = "[0 0 0]"; - rhs_config["name"] = static_id(); + rhs_config["name"] = static_id(); config.add(rhs_config, "rhs"); ConfigType initial_value_config; initial_value_config["lower_left"] = "[0.0]"; @@ -286,13 +287,13 @@ public: initial_value_config["variable"] = "x"; initial_value_config["values.0"] = "[1 0 2.5]"; initial_value_config["values.1"] = "[0.125 0 0.25]"; - initial_value_config["order"] = "0"; + initial_value_config["order"] = "0"; config.add(initial_value_config, "initial_values"); ConfigType boundary_value_config = DefaultBoundaryValueType::default_config(); boundary_value_config["type"] = DefaultBoundaryValueType::static_id(); boundary_value_config["variable"] = "x"; boundary_value_config["expression"] = "[1-x[0]*0.875 0 2.5-x[0]*2.25]"; - boundary_value_config["order"] = "1"; + boundary_value_config["order"] = "1"; config.add(boundary_value_config, "boundary_values"); if (sub_name.empty()) return config; @@ -303,7 +304,7 @@ public: } } // ... default_config(...) - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; diff --git a/dune/gdt/test/hyperbolic/problems/transport.hh b/dune/gdt/test/hyperbolic/problems/transport.hh index bf5f8302845fc2d535fd501a681319c820f1bb45..3918c4683b1070015eff47e6fbfe057d98a023ef 100644 --- a/dune/gdt/test/hyperbolic/problems/transport.hh +++ b/dune/gdt/test/hyperbolic/problems/transport.hh @@ -101,8 +101,9 @@ template <class EntityImp, class DomainFieldImp, size_t domainDim, class RangeFi class InitialValues : public DS::GlobalFunctionInterface<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, rangeDimCols> { - typedef typename DS::GlobalFunctionInterface<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, - rangeDimCols> BaseType; + typedef + typename DS::GlobalFunctionInterface<EntityImp, DomainFieldImp, domainDim, RangeFieldImp, rangeDim, rangeDimCols> + BaseType; public: using BaseType::dimDomain; @@ -163,11 +164,13 @@ class TransportSolution typename LocalizableFunctionType::EntityType, typename LocalizableFunctionType::DomainFieldType, LocalizableFunctionType::dimDomain, typename LocalizableFunctionType::RangeFieldType, LocalizableFunctionType::dimRange, LocalizableFunctionType::dimRangeCols>, - double> BaseType; + double> + BaseType; using typename BaseType::TimeIndependentFunctionType; typedef PeriodicTransportFunction<typename LocalizableFunctionType::EntityType, typename LocalizableFunctionType::DomainFieldType, - LocalizableFunctionType::dimDomain> DomainTransportFunctionType; + LocalizableFunctionType::dimDomain> + DomainTransportFunctionType; typedef typename DomainTransportFunctionType::DomainType DomainType; @@ -225,8 +228,8 @@ public: using typename BaseType::DummyEntityType; typedef typename Dune::Stuff::Functions::Affine<DummyEntityType, R, dimRange, R, dimRange, dimDomain> FluxAffineFunctionType; - typedef - typename Dune::GDT::GlobalFunctionBasedAnalyticalFlux<FluxAffineFunctionType, E, D, d, R, r, rC> DefaultFluxType; + typedef typename Dune::GDT::GlobalFunctionBasedAnalyticalFlux<FluxAffineFunctionType, E, D, d, R, r, rC> + DefaultFluxType; using typename BaseType::DefaultInitialValueType; using typename BaseType::DefaultRHSType; using typename BaseType::DefaultBoundaryValueType; @@ -269,7 +272,7 @@ public: return boundary_config; } - static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), + static std::unique_ptr<ThisType> create(const ConfigType cfg = default_config(), const std::string sub_name = static_id()) { const ConfigType config = cfg.has_sub(sub_name) ? cfg.sub(sub_name) : cfg; @@ -292,7 +295,7 @@ public: ConfigType flux_config; flux_config["A.0"] = "[1]"; flux_config["A.1"] = "[2]"; - flux_config["b"] = "[0 0; 0 0]"; + flux_config["b"] = "[0 0; 0 0]"; config.add(flux_config, "flux", true); ConfigType initial_value_config; initial_value_config["lower_left"] = "[0.0 0.0 0.0]"; @@ -301,7 +304,7 @@ public: initial_value_config["num_elements"] = "[5]"; else initial_value_config["num_elements"] = "[5 5 1]"; - initial_value_config["variable"] = "x"; + initial_value_config["variable"] = "x"; if (dimDomain == 1) initial_value_config["values"] = "[0.0 " "10000*((x[0]-0.2)^2)*((x[0]-0.4)^2)*exp(0.02-((x[0]-0.2)^2)-((x[0]-0.4)^2)) " @@ -315,7 +318,7 @@ public: "2)*((x[1]-0.4)^2)*exp(0.02-((x[1]-0.2)^2)-((x[1]-0.4)^2)) 0 0 0 ") + std::string("0 0 0 0 0 ") + std::string("0 0 0 1 0 ") + std::string("0 0 0 0 0]"); initial_value_config["order"] = "10"; - initial_value_config["name"] = static_id(); + initial_value_config["name"] = static_id(); config.add(initial_value_config, "initial_values", true); if (sub_name.empty()) return config; @@ -419,7 +422,8 @@ public: out << "+======================================================================+\n" << "|+====================================================================+|\n" << "|| Testcase: Transport ||\n" - << "|+--------------------------------------------------------------------+|\n" << domainstring + << "|+--------------------------------------------------------------------+|\n" + << domainstring << "|| time = [0, " + DSC::toString(BaseType::t_end()) + "] ||\n" << "|| flux = u[0] ||\n" diff --git a/dune/gdt/test/instationary-eocstudy.hh b/dune/gdt/test/instationary-eocstudy.hh index 314fc7660d4af7559fc99b5f3ed692bfb420d721..2f3011cad4e58a7ca4226183bad52227a7da03ff 100644 --- a/dune/gdt/test/instationary-eocstudy.hh +++ b/dune/gdt/test/instationary-eocstudy.hh @@ -218,12 +218,12 @@ public: auto current_solution_on_level_it = current_solution_on_level_->begin(); const auto current_solution_on_level_it_last = --current_solution_on_level_->end(); const auto current_solution_it_end = current_solution_->end(); - auto last_time = current_solution_->begin()->first; + auto last_time = current_solution_->begin()->first; for (auto current_solution_it = current_solution_->begin(); current_solution_it != current_solution_it_end; ++current_solution_it) { const auto time = current_solution_it->first; const auto time_on_level = current_solution_on_level_it->first; - const auto inserted_it = time_prolongated_current_solution_on_level.emplace_hint( + const auto inserted_it = time_prolongated_current_solution_on_level.emplace_hint( time_prolongated_current_solution_on_level_it_end, time, current_solution_on_level_it->second); if (time_on_level < time && current_solution_on_level_it != current_solution_on_level_it_last) { // compute weighted average of the two values of current_solution_on_level_ @@ -300,7 +300,7 @@ protected: if (!reference_solution_computed_) { reference_discretization_ = Stuff::Common::make_unique<DiscretizationType>(Discretizer::discretize( test_case_, test_case_, test_case_.reference_level(), test_case_.periodic_directions())); - reference_solution_ = Stuff::Common::make_unique<DiscreteSolutionType>(reference_discretization_->solve()); + reference_solution_ = Stuff::Common::make_unique<DiscreteSolutionType>(reference_discretization_->solve()); reference_solution_computed_ = true; if (!visualize_prefix_.empty()) { size_t counter = 0; @@ -326,7 +326,7 @@ protected: ++reference_solution_it) { const double time = reference_solution_it->first; const auto discrete_exact_solution_at_time = exact_solution->evaluate_at_time(time); - const auto inserted_it = discrete_exact_solution_->emplace_hint( + const auto inserted_it = discrete_exact_solution_->emplace_hint( discrete_exact_solution_->end(), time, reference_solution_it->second); project(*discrete_exact_solution_at_time, inserted_it->second); } diff --git a/dune/gdt/test/linearelliptic/cg-discretization.hh b/dune/gdt/test/linearelliptic/cg-discretization.hh index 0d569cd956450b6ba0e23675004674eb7e3ca152..63fdfd276d9d8d48b6c43d9e2a0dcbae922e0d54 100644 --- a/dune/gdt/test/linearelliptic/cg-discretization.hh +++ b/dune/gdt/test/linearelliptic/cg-discretization.hh @@ -43,7 +43,8 @@ struct linearelliptic_CG_discretization : public ::testing::Test la_backend, 1, typename TestCaseType::ProblemType::RangeFieldType, - 1> Discretizer; + 1> + Discretizer; Dune::GDT::Test::LinearEllipticEocStudy<TestCaseType, Discretizer> eoc_study(test_case); try { Dune::Stuff::Test::check_eoc_study_for_success(eoc_study, eoc_study.run(DSC_LOG_INFO)); diff --git a/dune/gdt/test/linearelliptic/cg-testcases.hh b/dune/gdt/test/linearelliptic/cg-testcases.hh index 854bd51c719ca904abf420c592c27072b9016f99..ff0b0a021cfe2d49b190027f9a0957108d0e380b 100644 --- a/dune/gdt/test/linearelliptic/cg-testcases.hh +++ b/dune/gdt/test/linearelliptic/cg-testcases.hh @@ -21,7 +21,8 @@ typedef testing::Types<Dune::GDT::LinearElliptic::AO2013TestCase<Dune::SGrid<2, Dune::GDT::LinearElliptic::ER2007TestCase<Dune::SGrid<2, 2>>, Dune::GDT::LinearElliptic::ESV2007TestCase<Dune::SGrid<2, 2>>, Dune::GDT::LinearElliptic::MixedBoundaryTestCase<Dune::SGrid<2, 2>>, - Dune::GDT::LinearElliptic::Spe10Model1TestCase<Dune::SGrid<2, 2>>> SGridTestCases; + Dune::GDT::LinearElliptic::Spe10Model1TestCase<Dune::SGrid<2, 2>>> + SGridTestCases; #if HAVE_DUNE_ALUGRID diff --git a/dune/gdt/test/linearelliptic/discretizers/cg.hh b/dune/gdt/test/linearelliptic/discretizers/cg.hh index f5984d689b93790ca94d02cf25eba9ba440cb7e3..ae9b72cde8261b08821d5f5c9e6f69f487bdffac 100644 --- a/dune/gdt/test/linearelliptic/discretizers/cg.hh +++ b/dune/gdt/test/linearelliptic/discretizers/cg.hh @@ -38,14 +38,15 @@ namespace LinearElliptic { * \brief Discretizes a linear elliptic PDE using a continuous Galerkin Finite Element method. */ template <class GridType, Stuff::Grid::ChooseLayer layer = Stuff::Grid::ChooseLayer::leaf, - ChooseSpaceBackend space_backend = default_cg_backend, + ChooseSpaceBackend space_backend = default_cg_backend, Stuff::LA::ChooseBackend la_backend = Stuff::LA::default_sparse_backend, int pol = 1, class RangeFieldType = double, size_t dimRange = 1> class CGDiscretizer { public: typedef ProblemInterface<typename GridType::template Codim<0>::Entity, typename GridType::ctype, GridType::dimension, - RangeFieldType, dimRange> ProblemType; + RangeFieldType, dimRange> + ProblemType; typedef CgSpaceProvider<GridType, layer, space_backend, pol, RangeFieldType, dimRange> SpaceProvider; typedef typename SpaceProvider::Type SpaceType; typedef typename Stuff::LA::Container<RangeFieldType, la_backend>::MatrixType MatrixType; diff --git a/dune/gdt/test/linearelliptic/discretizers/ipdg.hh b/dune/gdt/test/linearelliptic/discretizers/ipdg.hh index c796413b68c024c0a99dccbcc08c9d94373cca51..1477e11ea4fc4401d147b1c2b60f2569dfc9d9f4 100644 --- a/dune/gdt/test/linearelliptic/discretizers/ipdg.hh +++ b/dune/gdt/test/linearelliptic/discretizers/ipdg.hh @@ -33,7 +33,7 @@ namespace LinearElliptic { * \brief Discretizes a linear elliptic PDE using an interior penalty discontinuous Galerkin Finite Element method. */ template <class GridType, Stuff::Grid::ChooseLayer layer = Stuff::Grid::ChooseLayer::leaf, - ChooseSpaceBackend spacebackend = default_dg_backend, + ChooseSpaceBackend spacebackend = default_dg_backend, Stuff::LA::ChooseBackend la_backend = Stuff::LA::default_sparse_backend, int pol = 1, class RangeFieldType = double, size_t dimRange = 1, LocalEllipticIpdgIntegrands::Method method = LocalEllipticIpdgIntegrands::default_method> @@ -41,7 +41,8 @@ class IpdgDiscretizer { public: typedef ProblemInterface<typename GridType::template Codim<0>::Entity, typename GridType::ctype, GridType::dimension, - RangeFieldType, dimRange> ProblemType; + RangeFieldType, dimRange> + ProblemType; typedef DgSpaceProvider<GridType, layer, spacebackend, pol, RangeFieldType, dimRange> SpaceProvider; typedef typename SpaceProvider::Type SpaceType; typedef typename Stuff::LA::Container<RangeFieldType, la_backend>::MatrixType MatrixType; diff --git a/dune/gdt/test/linearelliptic/estimators/swipdg-fluxreconstruction.hh b/dune/gdt/test/linearelliptic/estimators/swipdg-fluxreconstruction.hh index 0948b1c1b4c5e8d292e99c5efbdac64805c71bb2..8c271715e8b5ab8d2a1d416775bd408cefbaa87f 100644 --- a/dune/gdt/test/linearelliptic/estimators/swipdg-fluxreconstruction.hh +++ b/dune/gdt/test/linearelliptic/estimators/swipdg-fluxreconstruction.hh @@ -33,31 +33,36 @@ namespace SwipdgFluxreconstrutionEstimators { static const size_t over_integrate = 2; -static std::string local_nonconformity_ESV2007_id() +static std::string +local_nonconformity_ESV2007_id() { return "eta_NC_ESV2007"; } -static std::string local_residual_ESV2007_id() +static std::string +local_residual_ESV2007_id() { return "eta_R_ESV2007"; } -static std::string local_diffusive_flux_ESV2007_id() +static std::string +local_diffusive_flux_ESV2007_id() { return "eta_DF_ESV2007"; } -static std::string ESV2007_id() +static std::string +ESV2007_id() { return "eta_ESV2007"; } -static std::string ESV2007_alternative_summation_id() +static std::string +ESV2007_alternative_summation_id() { return ESV2007_id() + "_alternative_summation"; } @@ -133,7 +138,7 @@ public: virtual ReturnType compute_locally(const EntityType& entity) override final { const auto local_difference = difference_.local_function(entity); - const auto result = local_operator_.apply2(*local_difference, *local_difference); + const auto result = local_operator_.apply2(*local_difference, *local_difference); assert(result.rows() >= 1); assert(result.cols() >= 1); return result[0][0]; @@ -239,7 +244,7 @@ public: virtual ReturnType compute_locally(const EntityType& entity) override final { const auto local_difference = difference_.local_function(entity); - auto result = local_operator_.apply2(*local_difference, *local_difference); + auto result = local_operator_.apply2(*local_difference, *local_difference); assert(result.rows() >= 1); assert(result.cols() >= 1); return result[0][0]; @@ -374,7 +379,7 @@ public: virtual ReturnType compute_locally(const EntityType& entity) override final { const auto local_discrete_solution = discrete_solution_.local_function(entity); - auto result = local_operator_.apply2(*local_discrete_solution, *local_discrete_solution); + auto result = local_operator_.apply2(*local_discrete_solution, *local_discrete_solution); assert(result.rows() >= 1); assert(result.cols() >= 1); return result[0][0]; @@ -553,7 +558,8 @@ class ESV2007AlternativeSummation : public ESV2007<SpaceType, VectorType, ForceType, DiffusionFactorType, DiffusionTensorType, GridViewType> { typedef ESV2007AlternativeSummation<SpaceType, VectorType, ForceType, DiffusionFactorType, DiffusionTensorType, - GridViewType> ThisType; + GridViewType> + ThisType; typedef ESV2007<SpaceType, VectorType, ForceType, DiffusionFactorType, DiffusionTensorType, GridViewType> BaseType; public: diff --git a/dune/gdt/test/linearelliptic/problems/AO2013.hh b/dune/gdt/test/linearelliptic/problems/AO2013.hh index 8b4429566a7352e3f269e0d1b0a8885bc8b41635..ef2d9c4c040c41fabe3af31cfae686082e71c420 100644 --- a/dune/gdt/test/linearelliptic/problems/AO2013.hh +++ b/dune/gdt/test/linearelliptic/problems/AO2013.hh @@ -60,42 +60,10 @@ public: AO2013Problem(const Stuff::Common::Configuration& grd_cfg = default_grid_cfg(), const Stuff::Common::Configuration& bnd_cfg = default_boundary_info_cfg()) - : BaseType(new CheckerboardFunctionType({0.0, 0.0}, {1.0, 1.0}, {6, 6}, {1.0, - 1.0, - 1.0, - 0.1, - 0.1, - 0.1, - 1.0, - 0.01, - 1.0, - 0.1, - 0.1, - 0.1, - 1.0, - 1.0, - 1.0, - 0.1, - 0.1, - 0.1, - 1.0, - 1.0, - 1.0, - 0.1, - 0.1, - 0.1, - 1.0, - 0.01, - 1.0, - 0.1, - 0.1, - 0.1, - 1.0, - 1.0, - 1.0, - 0.1, - 0.1, - 0.1}, + : BaseType(new CheckerboardFunctionType({0.0, 0.0}, {1.0, 1.0}, {6, 6}, + {1.0, 1.0, 1.0, 0.1, 0.1, 0.1, 1.0, 0.01, 1.0, 0.1, 0.1, 0.1, + 1.0, 1.0, 1.0, 0.1, 0.1, 0.1, 1.0, 1.0, 1.0, 0.1, 0.1, 0.1, + 1.0, 0.01, 1.0, 0.1, 0.1, 0.1, 1.0, 1.0, 1.0, 0.1, 0.1, 0.1}, "diffusion_factor"), new MatrixConstantFunctionType(Stuff::Functions::internal::unit_matrix<RangeFieldImp, 2>(), "diffusion_tensor"), diff --git a/dune/gdt/test/linearelliptic/problems/ER2007.hh b/dune/gdt/test/linearelliptic/problems/ER2007.hh index e2c7e157863a287702bb365f7bddbfd554fafff2..1073dc422807eb28fdb439055308952125aa94e1 100644 --- a/dune/gdt/test/linearelliptic/problems/ER2007.hh +++ b/dune/gdt/test/linearelliptic/problems/ER2007.hh @@ -60,7 +60,7 @@ public: return Stuff::Grid::BoundaryInfoConfigs::AllDirichlet::default_config(); } - ER2007Problem(const size_t integration_order = default_integration_order, + ER2007Problem(const size_t integration_order = default_integration_order, const Stuff::Common::Configuration& grd_cfg = default_grid_cfg(), const Stuff::Common::Configuration& bnd_cfg = default_boundary_info_cfg()) : BaseType( diff --git a/dune/gdt/test/linearelliptic/problems/ESV2007.hh b/dune/gdt/test/linearelliptic/problems/ESV2007.hh index c7086cb0bae06fd7cdcf99ce538556ab1df18db5..a20d3f0ff9b274528d0095d6c9ef35e599addd6b 100644 --- a/dune/gdt/test/linearelliptic/problems/ESV2007.hh +++ b/dune/gdt/test/linearelliptic/problems/ESV2007.hh @@ -60,7 +60,7 @@ public: return Stuff::Grid::BoundaryInfoConfigs::AllDirichlet::default_config(); } - ESV2007Problem(const size_t integration_order = default_integration_order, + ESV2007Problem(const size_t integration_order = default_integration_order, const Stuff::Common::Configuration& grd_cfg = default_grid_cfg(), const Stuff::Common::Configuration& bnd_cfg = default_boundary_info_cfg()) : BaseType(new ScalarConstantFunctionType(1, "diffusion_factor"), diff --git a/dune/gdt/test/linearelliptic/problems/interface.hh b/dune/gdt/test/linearelliptic/problems/interface.hh index 4d45e494f39e93355c5a550c2d6be5f031a34e83..5ead66e20a22a4a200dbcb07061650fc25173340 100644 --- a/dune/gdt/test/linearelliptic/problems/interface.hh +++ b/dune/gdt/test/linearelliptic/problems/interface.hh @@ -37,7 +37,8 @@ public: typedef Stuff::LocalizableFunctionInterface<EntityType, DomainFieldType, dimDomain, RangeFieldType, 1, 1> DiffusionFactorType; typedef Stuff::LocalizableFunctionInterface<EntityType, DomainFieldType, dimDomain, RangeFieldType, dimDomain, - dimDomain> DiffusionTensorType; + dimDomain> + DiffusionTensorType; typedef Stuff::LocalizableFunctionInterface<EntityType, DomainFieldType, dimDomain, RangeFieldType, dimRange> FunctionType; diff --git a/dune/gdt/test/linearelliptic/problems/mixedboundary.hh b/dune/gdt/test/linearelliptic/problems/mixedboundary.hh index 7258b3316f7b88cf75e0eb1e70b12814d683308f..e83554bccf778dc46aa68df8ec5201494b857015 100644 --- a/dune/gdt/test/linearelliptic/problems/mixedboundary.hh +++ b/dune/gdt/test/linearelliptic/problems/mixedboundary.hh @@ -64,7 +64,7 @@ public: return cfg; } - MixedBoundaryProblem(const size_t integration_order = default_integration_order, + MixedBoundaryProblem(const size_t integration_order = default_integration_order, const Stuff::Common::Configuration& grd_cfg = default_grid_cfg(), const Stuff::Common::Configuration& bnd_cfg = default_boundary_info_cfg()) : BaseType(new ScalarConstantFunctionType(1, "diffusion_factor"), diff --git a/dune/gdt/test/linearelliptic/swipdg-discretization.hh b/dune/gdt/test/linearelliptic/swipdg-discretization.hh index 3f7e813cdad8419faa09300c555a3ef069bfaec4..b07edb3a6780d3349b8d77156995df1f1227c269 100644 --- a/dune/gdt/test/linearelliptic/swipdg-discretization.hh +++ b/dune/gdt/test/linearelliptic/swipdg-discretization.hh @@ -44,7 +44,8 @@ struct linearelliptic_SWIPDG_discretization : public ::testing::Test polOrder, typename TestCaseType::ProblemType::RangeFieldType, 1, - LocalEllipticIpdgIntegrands::Method::swipdg> Discretizer; + LocalEllipticIpdgIntegrands::Method::swipdg> + Discretizer; Dune::GDT::Test::LinearEllipticEocStudy<TestCaseType, Discretizer> eoc_study(test_case); try { Dune::Stuff::Test::check_eoc_study_for_success(eoc_study, eoc_study.run(DSC_LOG_INFO)); diff --git a/dune/gdt/test/linearelliptic/swipdg-estimator-testcases.hh b/dune/gdt/test/linearelliptic/swipdg-estimator-testcases.hh index bcf27d7558b8b30efbff7d23760cc7b9b9f3640b..74fa5c950859a82abcb3c65e7f977e305e2f128a 100644 --- a/dune/gdt/test/linearelliptic/swipdg-estimator-testcases.hh +++ b/dune/gdt/test/linearelliptic/swipdg-estimator-testcases.hh @@ -21,10 +21,11 @@ #if HAVE_DUNE_ALUGRID -typedef testing::Types<Dune::GDT::LinearElliptic::AO2013TestCase<Dune::ALUGrid<2, 2, Dune::simplex, Dune::conforming>>, - Dune::GDT::LinearElliptic::ESV2007TestCase<Dune::ALUGrid<2, 2, Dune::simplex, Dune::conforming>>, - Dune::GDT::LinearElliptic:: - Spe10Model1TestCase<Dune::ALUGrid<2, 2, Dune::simplex, Dune::conforming>>> AluGridTestCases; +typedef testing:: + Types<Dune::GDT::LinearElliptic::AO2013TestCase<Dune::ALUGrid<2, 2, Dune::simplex, Dune::conforming>>, + Dune::GDT::LinearElliptic::ESV2007TestCase<Dune::ALUGrid<2, 2, Dune::simplex, Dune::conforming>>, + Dune::GDT::LinearElliptic::Spe10Model1TestCase<Dune::ALUGrid<2, 2, Dune::simplex, Dune::conforming>>> + AluGridTestCases; #endif // HAVE_DUNE_ALUGRID diff --git a/dune/gdt/test/linearelliptic/swipdg-estimators.hh b/dune/gdt/test/linearelliptic/swipdg-estimators.hh index aeb3063691a5af7d03c84a0b214d486a9d01fa97..2f06764b5efe425b3a30d19994ae025a654a56a4 100644 --- a/dune/gdt/test/linearelliptic/swipdg-estimators.hh +++ b/dune/gdt/test/linearelliptic/swipdg-estimators.hh @@ -56,8 +56,8 @@ private: DiffusionTensorType> LocalDiffusiveFluxESV2007Estimator; typedef LinearElliptic::SwipdgFluxreconstrutionEstimators::ESV2007<SpaceType, VectorType, FunctionType, - DiffusionFactorType, - DiffusionTensorType> ESV2007Estimator; + DiffusionFactorType, DiffusionTensorType> + ESV2007Estimator; typedef LinearElliptic::SwipdgFluxreconstrutionEstimators:: ESV2007AlternativeSummation<SpaceType, VectorType, FunctionType, DiffusionFactorType, DiffusionTensorType> ESV2007AlternativeSummationEstimator; @@ -164,7 +164,8 @@ struct linearelliptic_SWIPDG_estimators : public ::testing::Test polOrder, typename TestCaseType::ProblemType::RangeFieldType, 1, - LocalEllipticIpdgIntegrands::Method::swipdg> Discretizer; + LocalEllipticIpdgIntegrands::Method::swipdg> + Discretizer; Dune::GDT::Test::LinearEllipticSwipdgEstimatorStudy<TestCaseType, Discretizer> eoc_study(test_case); try { Dune::Stuff::Test::check_eoc_study_for_success(eoc_study, eoc_study.run(DSC_LOG_INFO)); diff --git a/dune/gdt/test/linearelliptic/swipdg-testcases.hh b/dune/gdt/test/linearelliptic/swipdg-testcases.hh index 5868371002b65c7d3ec179ede43ca058b3ef285d..78618acdc19fb9961a790af72294bd25ab5d3972 100644 --- a/dune/gdt/test/linearelliptic/swipdg-testcases.hh +++ b/dune/gdt/test/linearelliptic/swipdg-testcases.hh @@ -25,7 +25,8 @@ typedef testing::Types<Dune::GDT::LinearElliptic::AO2013TestCase<Dune::SGrid<2, , Dune::GDT::LinearElliptic::Spe10Model1TestCase<Dune::SGrid<2, 2>> #endif - > SGridTestCases; + > + SGridTestCases; #if HAVE_DUNE_ALUGRID diff --git a/dune/gdt/test/operators/base.hh b/dune/gdt/test/operators/base.hh index faa48a6498d15971144c5eab7984a4a12d34d2cc..ac227d3420c2e516a647c22df97c59d5de564593 100644 --- a/dune/gdt/test/operators/base.hh +++ b/dune/gdt/test/operators/base.hh @@ -97,8 +97,8 @@ struct LocalizableProductBase : public OperatorBase<SpaceType> template <class ProductImp> void localizable_product_test(ProductImp& prod) { - const auto& DUNE_UNUSED(source) = prod.source(); - const auto& DUNE_UNUSED(range) = prod.range(); + const auto& DUNE_UNUSED(source) = prod.source(); + const auto& DUNE_UNUSED(range) = prod.range(); auto& DUNE_UNUSED(non_const_range) = prod.range(); Stuff::Grid::Walker<GridViewType> walker(this->space_.grid_view()); @@ -120,10 +120,10 @@ struct MatrixOperatorBase : public OperatorBase<SpaceType> template <class OperatorImp> void matrix_operator_test(OperatorImp& op) { - const auto& DUNE_UNUSED(matrix) = op.matrix(); - auto& DUNE_UNUSED(non_const_matrix) = op.matrix(); + const auto& DUNE_UNUSED(matrix) = op.matrix(); + auto& DUNE_UNUSED(non_const_matrix) = op.matrix(); const auto& DUNE_UNUSED(source_space) = op.source_space(); - const auto& DUNE_UNUSED(range_space) = op.range_space(); + const auto& DUNE_UNUSED(range_space) = op.range_space(); Stuff::Grid::Walker<GridViewType> walker(this->space_.grid_view()); walker.add(op); diff --git a/dune/gdt/test/operators/darcy.hh b/dune/gdt/test/operators/darcy.hh index 0df4b92594c3b65137a02f2efa67cdafbd6629ab..05ef713b3a7646728730c0ed9909412084599440 100644 --- a/dune/gdt/test/operators/darcy.hh +++ b/dune/gdt/test/operators/darcy.hh @@ -72,7 +72,7 @@ struct DarcyOperatorTest : public ::testing::Test desired_output( "x", std::vector<std::string>({"x[1]", "x[0]"}), 1, "desired output", {{"0.0", "1.0"}, {"1.0", "0.0"}}); - const RangeFieldType l2_error = make_l2_operator(range_space.grid_view(), 2)->induced_norm(desired_output - range); + const RangeFieldType l2_error = make_l2_operator(range_space.grid_view(), 2)->induced_norm(desired_output - range); const RangeFieldType l2_error_expected = expected_result_("l2", desired_output, range_space.grid_view()); EXPECT_LE(l2_error, l2_error_expected); diff --git a/dune/gdt/test/operators/elliptic.hh b/dune/gdt/test/operators/elliptic.hh index af2de892a4eb0bb0bb73f65f7224e87dee9bab29..8e498a1ac07943a1d8669add3a530a1ca2feda9d 100644 --- a/dune/gdt/test/operators/elliptic.hh +++ b/dune/gdt/test/operators/elliptic.hh @@ -106,7 +106,8 @@ struct EllipticLocalizableProductTest : public EllipticProductBase<SpaceType>, p GridViewType, ScalarFunctionType, ScalarFunctionType, - double> OnlyFactorType; + double> + OnlyFactorType; OnlyFactorType DUNE_UNUSED(factor_only)(diffusion_factor, grid_view, range, source); OnlyFactorType DUNE_UNUSED(factor_only_with_over_integrate)(1, diffusion_factor, grid_view, range, source); @@ -115,7 +116,8 @@ struct EllipticLocalizableProductTest : public EllipticProductBase<SpaceType>, p GridViewType, ExpressionFunctionType, ExpressionFunctionType, - double> OnlyTensorType; + double> + OnlyTensorType; OnlyTensorType DUNE_UNUSED(tensor_only)(diffusion_tensor, grid_view, range, source); OnlyTensorType DUNE_UNUSED(tensor_only_with_over_integrate)(1, diffusion_tensor, grid_view, range, source); @@ -124,7 +126,8 @@ struct EllipticLocalizableProductTest : public EllipticProductBase<SpaceType>, p GridViewType, ExpressionFunctionType, ExpressionFunctionType, - double> BothType; + double> + BothType; BothType DUNE_UNUSED(both)(diffusion_factor, diffusion_tensor, grid_view, range, source); BothType DUNE_UNUSED(both_with_over_integrate)(1, diffusion_factor, diffusion_tensor, grid_view, range, source); } // ... constructible_by_ctor(...) @@ -156,7 +159,7 @@ struct EllipticLocalizableProductTest : public EllipticProductBase<SpaceType>, p auto product = make_elliptic_localizable_product( this->factor_, this->tensor_function_, this->space_.grid_view(), function, function); const auto result = product->apply2(); - auto product_tbb = make_elliptic_localizable_product( + auto product_tbb = make_elliptic_localizable_product( this->factor_, this->tensor_function_, this->space_.grid_view(), function, function); product_tbb->walk(true); const auto result_tbb = product_tbb->apply2(); @@ -352,25 +355,24 @@ struct EllipticMatrixOperatorTest : public EllipticProductBase<SpaceType>, publi MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_no_matrix_4)(diffusion_factor, diffusion_tensor, space); + double> + DUNE_UNUSED(both_no_matrix_4)(diffusion_factor, diffusion_tensor, space); EllipticMatrixOperator<ExpressionFunctionType, TensorFunctionType, SpaceType, MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_no_matrix_5)(diffusion_factor, diffusion_tensor, space, grid_view); + double> + DUNE_UNUSED(both_no_matrix_5)(diffusion_factor, diffusion_tensor, space, grid_view); EllipticMatrixOperator<ExpressionFunctionType, TensorFunctionType, SpaceType, MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_no_matrix_6)(diffusion_factor, - diffusion_tensor, - space, - space, - grid_view); + double> + DUNE_UNUSED(both_no_matrix_6)(diffusion_factor, diffusion_tensor, space, space, grid_view); // with over_integrate // simplified argument list EllipticMatrixOperator<ExpressionFunctionType, TensorFunctionType, SpaceType> DUNE_UNUSED(both_no_matrix_7)( @@ -386,30 +388,24 @@ struct EllipticMatrixOperatorTest : public EllipticProductBase<SpaceType>, publi MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_no_matrix_10)(1, diffusion_factor, diffusion_tensor, space); + double> + DUNE_UNUSED(both_no_matrix_10)(1, diffusion_factor, diffusion_tensor, space); EllipticMatrixOperator<ExpressionFunctionType, TensorFunctionType, SpaceType, MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_no_matrix_11)(1, - diffusion_factor, - diffusion_tensor, - space, - grid_view); + double> + DUNE_UNUSED(both_no_matrix_11)(1, diffusion_factor, diffusion_tensor, space, grid_view); EllipticMatrixOperator<ExpressionFunctionType, TensorFunctionType, SpaceType, MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_no_matrix_12)(1, - diffusion_factor, - diffusion_tensor, - space, - space, - grid_view); + double> + DUNE_UNUSED(both_no_matrix_12)(1, diffusion_factor, diffusion_tensor, space, space, grid_view); // with matrix // without over_integrate // simplified argument list @@ -426,30 +422,24 @@ struct EllipticMatrixOperatorTest : public EllipticProductBase<SpaceType>, publi MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_matrix_4)(diffusion_factor, diffusion_tensor, matrix, space); + double> + DUNE_UNUSED(both_matrix_4)(diffusion_factor, diffusion_tensor, matrix, space); EllipticMatrixOperator<ExpressionFunctionType, TensorFunctionType, SpaceType, MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_matrix_5)(diffusion_factor, - diffusion_tensor, - matrix, - space, - grid_view); + double> + DUNE_UNUSED(both_matrix_5)(diffusion_factor, diffusion_tensor, matrix, space, grid_view); EllipticMatrixOperator<ExpressionFunctionType, TensorFunctionType, SpaceType, MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_matrix_6)(diffusion_factor, - diffusion_tensor, - matrix, - space, - space, - grid_view); + double> + DUNE_UNUSED(both_matrix_6)(diffusion_factor, diffusion_tensor, matrix, space, space, grid_view); // with over_integrate // simplified argument list EllipticMatrixOperator<ExpressionFunctionType, TensorFunctionType, SpaceType> DUNE_UNUSED(both_matrix_7)( @@ -465,19 +455,16 @@ struct EllipticMatrixOperatorTest : public EllipticProductBase<SpaceType>, publi MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_matrix_10)(1, diffusion_factor, diffusion_tensor, matrix, space); + double> + DUNE_UNUSED(both_matrix_10)(1, diffusion_factor, diffusion_tensor, matrix, space); EllipticMatrixOperator<ExpressionFunctionType, TensorFunctionType, SpaceType, MatrixType, GridViewType, SpaceType, - double> DUNE_UNUSED(both_matrix_11)(1, - diffusion_factor, - diffusion_tensor, - matrix, - space, - grid_view); + double> + DUNE_UNUSED(both_matrix_11)(1, diffusion_factor, diffusion_tensor, matrix, space, grid_view); EllipticMatrixOperator<ExpressionFunctionType, TensorFunctionType, SpaceType, @@ -493,7 +480,7 @@ struct EllipticMatrixOperatorTest : public EllipticProductBase<SpaceType>, publi const auto& diffusion_factor = this->factor_; const auto& diffusion_tensor = this->tensor_function_; const auto& space = this->space_; - const auto& grid_view = this->space_.grid_view(); + const auto& grid_view = this->space_.grid_view(); MatrixType matrix(space.mapper().size(), space.mapper().size(), space.compute_volume_pattern()); // both diffusion factor and tensor @@ -564,7 +551,7 @@ struct EllipticMatrixOperatorTest : public EllipticProductBase<SpaceType>, publi project(space.grid_view(), function, discrete_function, 2); // compute product const auto result = op->apply2(discrete_function, discrete_function); - auto op_tbb = make_elliptic_matrix_operator<MatrixType>(diffusion_factor, diffusion_tensor, space); + auto op_tbb = make_elliptic_matrix_operator<MatrixType>(diffusion_factor, diffusion_tensor, space); op_tbb->assemble(true); const auto result_tbb = op_tbb->apply2(discrete_function, discrete_function); EXPECT_DOUBLE_EQ(result_tbb, result); @@ -655,13 +642,13 @@ struct EllipticOperatorTest : public EllipticProductBase<SpaceType>, public Oper const auto& diffusion_tensor = this->tensor_function_; const auto& grid_view = this->space_.grid_view(); - auto DUNE_UNUSED(only_factor) = make_elliptic_operator(grid_view, diffusion_factor); + auto DUNE_UNUSED(only_factor) = make_elliptic_operator(grid_view, diffusion_factor); auto DUNE_UNUSED(only_factor_w_over) = make_elliptic_operator(grid_view, diffusion_factor, 1); - auto DUNE_UNUSED(only_tensor) = make_elliptic_operator(grid_view, diffusion_tensor); + auto DUNE_UNUSED(only_tensor) = make_elliptic_operator(grid_view, diffusion_tensor); auto DUNE_UNUSED(only_tensor_w_over) = make_elliptic_operator(grid_view, diffusion_tensor, 1); - auto DUNE_UNUSED(both) = make_elliptic_operator(grid_view, diffusion_factor, diffusion_tensor); + auto DUNE_UNUSED(both) = make_elliptic_operator(grid_view, diffusion_factor, diffusion_tensor); auto DUNE_UNUSED(both_w_over) = make_elliptic_operator(grid_view, diffusion_factor, diffusion_tensor, 1); } // ... constructible_by_factory() diff --git a/dune/gdt/test/operators/l2.hh b/dune/gdt/test/operators/l2.hh index e369dc0d7673105f5be7b8c844af19ff8523940b..0d55cc014a506cecd93fecdd40ab38eb7eeb0419 100644 --- a/dune/gdt/test/operators/l2.hh +++ b/dune/gdt/test/operators/l2.hh @@ -53,7 +53,7 @@ struct L2LocalizableProductTest : public WeightedL2ProductBase<SpaceType>, publi const auto& source = this->scalar_function_; const auto& range = this->scalar_function_; - auto DUNE_UNUSED(wo_over_integrate) = make_l2_localizable_product(grid_view, range, source); + auto DUNE_UNUSED(wo_over_integrate) = make_l2_localizable_product(grid_view, range, source); auto DUNE_UNUSED(with_over_integrate) = make_l2_localizable_product(grid_view, range, source, 1); } // ... constructible_by_factory() @@ -232,7 +232,7 @@ struct L2OperatorTest : public WeightedL2ProductBase<SpaceType>, public Operator { const auto& grid_view = this->space_.grid_view(); - auto DUNE_UNUSED(wo_over_integrate) = make_l2_operator(grid_view); + auto DUNE_UNUSED(wo_over_integrate) = make_l2_operator(grid_view); auto DUNE_UNUSED(with_over_integrate) = make_l2_operator(grid_view, 1); } // ... constructible_by_factory() diff --git a/dune/gdt/test/operators/laplace.hh b/dune/gdt/test/operators/laplace.hh index 60c2dfe350f5930dff7725a36a1276fe2a92d47c..9918ea385832eef6ed6de2414331b5ee7de5c9f5 100644 --- a/dune/gdt/test/operators/laplace.hh +++ b/dune/gdt/test/operators/laplace.hh @@ -53,7 +53,7 @@ struct LaplaceLocalizableProductTest : public EllipticProductBase<SpaceType>, pu const auto& source = this->scalar_function_; const auto& range = this->scalar_function_; - auto DUNE_UNUSED(wo_over_integrate) = make_laplace_localizable_product(grid_view, range, source); + auto DUNE_UNUSED(wo_over_integrate) = make_laplace_localizable_product(grid_view, range, source); auto DUNE_UNUSED(with_over_integrate) = make_laplace_localizable_product(grid_view, range, source, 1); } // ... constructible_by_factory() @@ -233,7 +233,7 @@ struct LaplaceOperatorTest : public EllipticProductBase<SpaceType>, public Opera { const auto& grid_view = this->space_.grid_view(); - auto DUNE_UNUSED(wo_over_integrate) = make_laplace_operator(grid_view); + auto DUNE_UNUSED(wo_over_integrate) = make_laplace_operator(grid_view); auto DUNE_UNUSED(with_over_integrate) = make_laplace_operator(grid_view, 1); } // ... constructible_by_factory() diff --git a/dune/gdt/test/operators/weighted-l2.hh b/dune/gdt/test/operators/weighted-l2.hh index 6ee658ff7e6e638ffe5ca5ac7ebdd952f6e01af4..40afc8877332b5be2c8006a63f177962e3b11e89 100644 --- a/dune/gdt/test/operators/weighted-l2.hh +++ b/dune/gdt/test/operators/weighted-l2.hh @@ -105,7 +105,8 @@ struct WeightedL2LocalizableProductTest : public WeightedL2ProductBase<SpaceType GridViewType, ScalarFunctionType, ScalarFunctionType, - double> CtorTestProductType; + double> + CtorTestProductType; CtorTestProductType DUNE_UNUSED(wo_over_integrate)(weight, grid_view, range, source); CtorTestProductType DUNE_UNUSED(with_over_integrate)(1, weight, grid_view, range, source); } // ... constructible_by_ctor(...) @@ -117,7 +118,7 @@ struct WeightedL2LocalizableProductTest : public WeightedL2ProductBase<SpaceType const auto& source = this->scalar_function_; const auto& range = this->scalar_function_; - auto DUNE_UNUSED(wo_over_integrate) = make_weighted_l2_localizable_product(weight, grid_view, range, source); + auto DUNE_UNUSED(wo_over_integrate) = make_weighted_l2_localizable_product(weight, grid_view, range, source); auto DUNE_UNUSED(with_over_integrate) = make_weighted_l2_localizable_product(weight, grid_view, range, source, 1); } // ... constructible_by_factory() @@ -310,7 +311,7 @@ struct WeightedL2OperatorTest : public WeightedL2ProductBase<SpaceType>, public const auto& weight = this->weight_; const auto& grid_view = this->space_.grid_view(); - auto DUNE_UNUSED(wo_over_integrate) = make_weighted_l2_operator(grid_view, weight); + auto DUNE_UNUSED(wo_over_integrate) = make_weighted_l2_operator(grid_view, weight); auto DUNE_UNUSED(with_over_integrate) = make_weighted_l2_operator(grid_view, weight, 1); } // ... constructible_by_factory() diff --git a/dune/gdt/test/operators__darcy.cc b/dune/gdt/test/operators__darcy.cc index 4e8e7a19cdc7500246d67848792d41661126a9e3..97a1287c8a688a0308050669a7ec609f29869f10 100644 --- a/dune/gdt/test/operators__darcy.cc +++ b/dune/gdt/test/operators__darcy.cc @@ -19,7 +19,8 @@ using namespace Dune::GDT::Test; typedef testing::Types< /*std::pair< SPACE_CG_FEM_ALUCONFORMGRID(2, 1, 1), SPACE_CG_FEM_ALUCONFORMGRID(2, 2, 1) > // <- TODO: enable once #40 is resolved ,*/ std:: - pair<SPACE_CG_FEM_ALUCONFORMGRID(2, 1, 1), SPACE_RT_PDELAB_ALUCONFORMGRID(2)>> SpaceTypes; + pair<SPACE_CG_FEM_ALUCONFORMGRID(2, 1, 1), SPACE_RT_PDELAB_ALUCONFORMGRID(2)>> + SpaceTypes; TYPED_TEST_CASE(DarcyOperatorTest, SpaceTypes); TYPED_TEST(DarcyOperatorTest, produces_correct_results) diff --git a/dune/gdt/test/projections/l2-global.hh b/dune/gdt/test/projections/l2-global.hh index dbd3d78b97c49ae7305e56bcd77367c6691e4622..276c345a751df186b36dac7e2fa2e1b6a9f27015 100644 --- a/dune/gdt/test/projections/l2-global.hh +++ b/dune/gdt/test/projections/l2-global.hh @@ -36,7 +36,7 @@ struct L2GlobalProjectionLocalizableOperatorTest make_global_l2_projection_localizable_operator(grid_view, source, range, 1); auto DUNE_UNUSED(w_grid_view_wo_over_integrate) = make_global_l2_projection_localizable_operator(grid_view, source, range); - auto DUNE_UNUSED(wo_grid_view_w_over_integrate) = make_global_l2_projection_localizable_operator(source, range, 1); + auto DUNE_UNUSED(wo_grid_view_w_over_integrate) = make_global_l2_projection_localizable_operator(source, range, 1); auto DUNE_UNUSED(wo_grid_view_wo_over_integrate) = make_global_l2_projection_localizable_operator(source, range); } // ... constructible_by_factory(...) }; @@ -50,7 +50,7 @@ struct L2GlobalProjectionOperatorTest { const auto& grid_view = this->space_.grid_view(); - auto DUNE_UNUSED(w_over_integrate) = make_global_l2_projection_operator(grid_view, 1); + auto DUNE_UNUSED(w_over_integrate) = make_global_l2_projection_operator(grid_view, 1); auto DUNE_UNUSED(wo_over_integrate) = make_global_l2_projection_operator(grid_view); } // ... constructible_by_factory(...) }; diff --git a/dune/gdt/test/projections/l2-local.hh b/dune/gdt/test/projections/l2-local.hh index f84e35d8f6a08274920d6cda7f93d48a40e23b0a..07c8257217f1b05a3f557ac630f749e315577118 100644 --- a/dune/gdt/test/projections/l2-local.hh +++ b/dune/gdt/test/projections/l2-local.hh @@ -36,7 +36,7 @@ struct L2LocalProjectionLocalizableOperatorTest make_local_l2_projection_localizable_operator(grid_view, source, range, 1); auto DUNE_UNUSED(w_grid_view_wo_over_integrate) = make_local_l2_projection_localizable_operator(grid_view, source, range); - auto DUNE_UNUSED(wo_grid_view_w_over_integrate) = make_local_l2_projection_localizable_operator(source, range, 1); + auto DUNE_UNUSED(wo_grid_view_w_over_integrate) = make_local_l2_projection_localizable_operator(source, range, 1); auto DUNE_UNUSED(wo_grid_view_wo_over_integrate) = make_local_l2_projection_localizable_operator(source, range); } // ... constructible_by_factory(...) }; @@ -50,7 +50,7 @@ struct L2LocalProjectionOperatorTest { const auto& grid_view = this->space_.grid_view(); - auto DUNE_UNUSED(w_over_integrate) = make_local_l2_projection_operator(grid_view, 1); + auto DUNE_UNUSED(w_over_integrate) = make_local_l2_projection_operator(grid_view, 1); auto DUNE_UNUSED(wo_over_integrate) = make_local_l2_projection_operator(grid_view); } // ... constructible_by_factory(...) }; diff --git a/dune/gdt/test/projections/l2.hh b/dune/gdt/test/projections/l2.hh index a0cdf5d7574738f6a881432176d166fc5c2a061a..246079e7eaa5c6e0b886c36999ef6f4cba9620a5 100644 --- a/dune/gdt/test/projections/l2.hh +++ b/dune/gdt/test/projections/l2.hh @@ -47,8 +47,8 @@ struct L2ProjectionOperatorTest { void constructible_by_factory() { - const auto& grid_view = this->space_.grid_view(); - auto DUNE_UNUSED(op_w_over_integrate) = make_l2_projection_operator(grid_view, 1); + const auto& grid_view = this->space_.grid_view(); + auto DUNE_UNUSED(op_w_over_integrate) = make_l2_projection_operator(grid_view, 1); auto DUNE_UNUSED(op_wo_over_integrate) = make_l2_projection_operator(grid_view); } // ... constructible_by_factory(...) diff --git a/dune/gdt/test/projections/lagrange.hh b/dune/gdt/test/projections/lagrange.hh index a4c842203bee189dedb22832dd240d75d67728aa..c153e07b0973c384d2cfb542b656f1e6364b75e3 100644 --- a/dune/gdt/test/projections/lagrange.hh +++ b/dune/gdt/test/projections/lagrange.hh @@ -33,7 +33,7 @@ struct LagrangeProjectionLocalizableOperatorTest auto& range = this->discrete_function_; auto DUNE_UNUSED(with_grid_view) = make_lagrange_projection_localizable_operator(grid_view, source, range); - auto DUNE_UNUSED(wo_grid_view) = make_lagrange_projection_localizable_operator(source, range); + auto DUNE_UNUSED(wo_grid_view) = make_lagrange_projection_localizable_operator(source, range); } // ... constructible_by_factory(...) }; // struct LagrangeProjectionLocalizableOperatorTest @@ -45,7 +45,7 @@ struct LagrangeProjectionOperatorTest void constructible_by_factory() { const auto& grid_view = this->space_.grid_view(); - auto DUNE_UNUSED(op) = make_lagrange_projection_operator(grid_view); + auto DUNE_UNUSED(op) = make_lagrange_projection_operator(grid_view); } // ... constructible_by_factory(...) void free_function_callable() diff --git a/dune/gdt/test/projections__cg_fem.cc b/dune/gdt/test/projections__cg_fem.cc index d921432bafd2518ebb7baabb0cd2cc69a45c9293..6a8bffcac2be00ebf69a0c40dc8fba353a96363a 100644 --- a/dune/gdt/test/projections__cg_fem.cc +++ b/dune/gdt/test/projections__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM(1) , SPACES_CG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProjectionTest, SpaceTypes); TYPED_TEST(ProjectionTest, produces_correct_results) diff --git a/dune/gdt/test/projections__cg_pdelab.cc b/dune/gdt/test/projections__cg_pdelab.cc index 52951250af8d5784d922c68d5eeabf4a094016dc..10193423412eec6b13b5d6f8e9338da082edb713 100644 --- a/dune/gdt/test/projections__cg_pdelab.cc +++ b/dune/gdt/test/projections__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB(1) , SPACES_CG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProjectionTest, SpaceTypes); TYPED_TEST(ProjectionTest, produces_correct_results) diff --git a/dune/gdt/test/projections__dg_fem.cc b/dune/gdt/test/projections__dg_fem.cc index 5c78ead3bce8f1fa4c4535e56cc6c1620b051386..739a3f18229f5bc2fadf3bec64cec91127544139 100644 --- a/dune/gdt/test/projections__dg_fem.cc +++ b/dune/gdt/test/projections__dg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_FEM(1) , SPACES_DG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProjectionTest, SpaceTypes); TYPED_TEST(ProjectionTest, produces_correct_results) diff --git a/dune/gdt/test/projections__dg_pdelab.cc b/dune/gdt/test/projections__dg_pdelab.cc index 8cc207cf7dc60650023cce64361d54c6e11b20d0..c7a6fb85412ee8afe8912a8d710a24ff84b89185 100644 --- a/dune/gdt/test/projections__dg_pdelab.cc +++ b/dune/gdt/test/projections__dg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_PDELAB(1) , SPACES_DG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProjectionTest, SpaceTypes); TYPED_TEST(ProjectionTest, produces_correct_results) diff --git a/dune/gdt/test/projections__fv_default.cc b/dune/gdt/test/projections__fv_default.cc index 93214f9912f2482d4d0112029d4981f87aaf9ea4..224c6703068fca60502b3c484677f88398242f63 100644 --- a/dune/gdt/test/projections__fv_default.cc +++ b/dune/gdt/test/projections__fv_default.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACE_FV_SGRID(1, 1), SPACE_FV_SGRID(2, 1), SPACE_FV_SGRI SPACE_FV_ALUCONFORMGRID(2, 1), SPACE_FV_ALUCONFORMGRID(3, 1), SPACE_FV_ALUCUBEGRID(2, 1), SPACE_FV_ALUCUBEGRID(3, 1) #endif // HAVE_DUNE_ALUGRID - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProjectionTest, SpaceTypes); TYPED_TEST(ProjectionTest, produces_correct_results) diff --git a/dune/gdt/test/projections__l2__cg_fem.cc b/dune/gdt/test/projections__l2__cg_fem.cc index 8e92b67304523e01793c440ef92279cbc6801e6c..ccbdce622ee3e37dac7d16b2eb06be20e02adba6 100644 --- a/dune/gdt/test/projections__l2__cg_fem.cc +++ b/dune/gdt/test/projections__l2__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM(1) , SPACES_CG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2__cg_pdelab.cc b/dune/gdt/test/projections__l2__cg_pdelab.cc index cfadb5050505cd6c123fae9205af694b239ee631..4662c316d835216320fc9d9aa3b6a72705b5d401 100644 --- a/dune/gdt/test/projections__l2__cg_pdelab.cc +++ b/dune/gdt/test/projections__l2__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB(1) , SPACES_CG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2__dg_fem.cc b/dune/gdt/test/projections__l2__dg_fem.cc index ebb9dcc4651201d7f51ef73819f2d152a03c1db9..e6083642e39e5da5301c9172d3eb0f88a962142a 100644 --- a/dune/gdt/test/projections__l2__dg_fem.cc +++ b/dune/gdt/test/projections__l2__dg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_FEM(1) , SPACES_DG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2__dg_pdelab.cc b/dune/gdt/test/projections__l2__dg_pdelab.cc index 0c4033de98c9fe7dfbcf7c1e546cf16f28d1be48..e9560f075249ec98c3b528dbe1be01b53e4115e8 100644 --- a/dune/gdt/test/projections__l2__dg_pdelab.cc +++ b/dune/gdt/test/projections__l2__dg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_PDELAB(1) , SPACES_DG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2__fv_default.cc b/dune/gdt/test/projections__l2__fv_default.cc index fcb0c20763b281f9eefdf45f3c51fbf3cd793400..672efcc4eee4700274123522bf1c3cc4add34587 100644 --- a/dune/gdt/test/projections__l2__fv_default.cc +++ b/dune/gdt/test/projections__l2__fv_default.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACE_FV_SGRID(1, 1), SPACE_FV_SGRID(2, 1), SPACE_FV_SGRI SPACE_FV_ALUCONFORMGRID(2, 1), SPACE_FV_ALUCONFORMGRID(3, 1), SPACE_FV_ALUCUBEGRID(2, 1), SPACE_FV_ALUCUBEGRID(3, 1) #endif // HAVE_DUNE_ALUGRID - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2__rt_pdelab.cc b/dune/gdt/test/projections__l2__rt_pdelab.cc index c94369df7534cc7ccfe5ad69edb08b4a6a3bc049..043e56930acd4d955444af59a22bc09c33c12f61 100644 --- a/dune/gdt/test/projections__l2__rt_pdelab.cc +++ b/dune/gdt/test/projections__l2__rt_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_RT_PDELAB , SPACES_RT_PDELAB_ALUGRID #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_global__cg_fem.cc b/dune/gdt/test/projections__l2_global__cg_fem.cc index 69198677b096b37aee2819b8d532558388d5c93d..3ca1577d1333a980a9316cff9d843cf110e9a564 100644 --- a/dune/gdt/test/projections__l2_global__cg_fem.cc +++ b/dune/gdt/test/projections__l2_global__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM(1) , SPACES_CG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2GlobalProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2GlobalProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_global__cg_pdelab.cc b/dune/gdt/test/projections__l2_global__cg_pdelab.cc index 5dac51676007bfe18f7781ef428b97a516031865..5be0790c14b11b4fc077f2ad42f5f486a9062b33 100644 --- a/dune/gdt/test/projections__l2_global__cg_pdelab.cc +++ b/dune/gdt/test/projections__l2_global__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB(1) , SPACES_CG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2GlobalProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2GlobalProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_global_localizable__cg_fem.cc b/dune/gdt/test/projections__l2_global_localizable__cg_fem.cc index d0ab5172b362ac5e95c61b8c098dd92138e9b5d7..6b02faa30cda776e5f4a2597d643e9a6c568cb50 100644 --- a/dune/gdt/test/projections__l2_global_localizable__cg_fem.cc +++ b/dune/gdt/test/projections__l2_global_localizable__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM(1) , SPACES_CG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2GlobalProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2GlobalProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_global_localizable__cg_pdelab.cc b/dune/gdt/test/projections__l2_global_localizable__cg_pdelab.cc index 53612eda5f6268c32934343f8c2eba9b9fc16b6e..72dc39ffe87740e549f521a516bc7b2695d59ee2 100644 --- a/dune/gdt/test/projections__l2_global_localizable__cg_pdelab.cc +++ b/dune/gdt/test/projections__l2_global_localizable__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB(1) , SPACES_CG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2GlobalProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2GlobalProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_local__dg_fem.cc b/dune/gdt/test/projections__l2_local__dg_fem.cc index d156fa178e0143dfe1686518c4408c1cbced4e6f..40dd7879cc7ccdef471555b6ca15095b6c0a3a17 100644 --- a/dune/gdt/test/projections__l2_local__dg_fem.cc +++ b/dune/gdt/test/projections__l2_local__dg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_FEM(1) , SPACES_DG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_local__dg_pdelab.cc b/dune/gdt/test/projections__l2_local__dg_pdelab.cc index 583f488e0f51d1ec9b46b7e92bf7bce0dcc85864..b44af1254d930a5289741e3c5ec6fabe5617d180 100644 --- a/dune/gdt/test/projections__l2_local__dg_pdelab.cc +++ b/dune/gdt/test/projections__l2_local__dg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_PDELAB(1) , SPACES_DG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_local__fv_default.cc b/dune/gdt/test/projections__l2_local__fv_default.cc index 51d8ea08f81499a8de434055bf6f7194d1ba1209..c0eb554509b16b2d271637ae558022aabb99f6ec 100644 --- a/dune/gdt/test/projections__l2_local__fv_default.cc +++ b/dune/gdt/test/projections__l2_local__fv_default.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACE_FV_SGRID(1, 1), SPACE_FV_SGRID(2, 1), SPACE_FV_SGRI SPACE_FV_ALUCONFORMGRID(2, 1), SPACE_FV_ALUCONFORMGRID(3, 1), SPACE_FV_ALUCUBEGRID(2, 1), SPACE_FV_ALUCUBEGRID(3, 1) #endif // HAVE_DUNE_ALUGRID - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_local__rt_pdelab.cc b/dune/gdt/test/projections__l2_local__rt_pdelab.cc index 723e582de17a42af3a8eda1791c7cd62bb43b34e..3ba8c4752823ed9fce5c6db8a3a4501a9b1131ab 100644 --- a/dune/gdt/test/projections__l2_local__rt_pdelab.cc +++ b/dune/gdt/test/projections__l2_local__rt_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_RT_PDELAB , SPACES_RT_PDELAB_ALUGRID #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProjectionOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_local_localizable__dg_fem.cc b/dune/gdt/test/projections__l2_local_localizable__dg_fem.cc index 953c9d63252ca4ff4eae28bbf57a0786576d89b7..eb37b60fdb8914ea6700eb540b16a88c423f12fe 100644 --- a/dune/gdt/test/projections__l2_local_localizable__dg_fem.cc +++ b/dune/gdt/test/projections__l2_local_localizable__dg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_FEM(1) , SPACES_DG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_local_localizable__dg_pdelab.cc b/dune/gdt/test/projections__l2_local_localizable__dg_pdelab.cc index 874133f5da1c521393e337d43a4a197dea0014c9..599ec0e9d9cf269a6bb62702980137b629963c59 100644 --- a/dune/gdt/test/projections__l2_local_localizable__dg_pdelab.cc +++ b/dune/gdt/test/projections__l2_local_localizable__dg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_PDELAB(1) , SPACES_DG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_local_localizable__fv_default.cc b/dune/gdt/test/projections__l2_local_localizable__fv_default.cc index 3121e980d1aaaa67db17f1d3bfbab841b77e1204..bfff618a2d56b26e37143451b653240381e2e276 100644 --- a/dune/gdt/test/projections__l2_local_localizable__fv_default.cc +++ b/dune/gdt/test/projections__l2_local_localizable__fv_default.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACE_FV_SGRID(1, 1), SPACE_FV_SGRID(2, 1), SPACE_FV_SGRI SPACE_FV_ALUCONFORMGRID(2, 1), SPACE_FV_ALUCONFORMGRID(3, 1), SPACE_FV_ALUCUBEGRID(2, 1), SPACE_FV_ALUCUBEGRID(3, 1) #endif // HAVE_DUNE_ALUGRID - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_local_localizable__rt_pdelab.cc b/dune/gdt/test/projections__l2_local_localizable__rt_pdelab.cc index cc43aaf2240f8e7624ac327002aeed52c9ddd15a..369b1e15ed23f1ab482a2ee46dfff348e0efab81 100644 --- a/dune/gdt/test/projections__l2_local_localizable__rt_pdelab.cc +++ b/dune/gdt/test/projections__l2_local_localizable__rt_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_RT_PDELAB , SPACES_RT_PDELAB_ALUGRID #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_localizable__cg_fem.cc b/dune/gdt/test/projections__l2_localizable__cg_fem.cc index 7c45d7a5c66df8ba1c915ff6feeb8bc97459b824..fddec5d1b75ca0464511a9b4bdedcd6bd8d909fc 100644 --- a/dune/gdt/test/projections__l2_localizable__cg_fem.cc +++ b/dune/gdt/test/projections__l2_localizable__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM(1) , SPACES_CG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_localizable__cg_pdelab.cc b/dune/gdt/test/projections__l2_localizable__cg_pdelab.cc index f855d2b2c85ce720e35dc9a6f25a9ebde9fc55db..c716f34bb8b51ddafacaddaa5bd29c7a557010ba 100644 --- a/dune/gdt/test/projections__l2_localizable__cg_pdelab.cc +++ b/dune/gdt/test/projections__l2_localizable__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB(1) , SPACES_CG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_localizable__dg_fem.cc b/dune/gdt/test/projections__l2_localizable__dg_fem.cc index 31ae363546f34a5a7f48955f19e1fc60b2c7404f..5ab39eb6cf782dd8a66e27991f105b0a22640b8e 100644 --- a/dune/gdt/test/projections__l2_localizable__dg_fem.cc +++ b/dune/gdt/test/projections__l2_localizable__dg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_FEM(1) , SPACES_DG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_localizable__dg_pdelab.cc b/dune/gdt/test/projections__l2_localizable__dg_pdelab.cc index 953c6671cac98c455d1d8a601fdb68d2d5013bda..8e473a550f1779bdb5f636caf9f5dd65ce6ece7f 100644 --- a/dune/gdt/test/projections__l2_localizable__dg_pdelab.cc +++ b/dune/gdt/test/projections__l2_localizable__dg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_PDELAB(1) , SPACES_DG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_localizable__fv_default.cc b/dune/gdt/test/projections__l2_localizable__fv_default.cc index e9e8fd1d7a9daf9bf245435f1358f50428f85728..1bd32db89031d22fc1fbb60069699c31f347ffc7 100644 --- a/dune/gdt/test/projections__l2_localizable__fv_default.cc +++ b/dune/gdt/test/projections__l2_localizable__fv_default.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACE_FV_SGRID(1, 1), SPACE_FV_SGRID(2, 1), SPACE_FV_SGRI SPACE_FV_ALUCONFORMGRID(2, 1), SPACE_FV_ALUCONFORMGRID(3, 1), SPACE_FV_ALUCUBEGRID(2, 1), SPACE_FV_ALUCUBEGRID(3, 1) #endif // HAVE_DUNE_ALUGRID - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__l2_localizable__rt_pdelab.cc b/dune/gdt/test/projections__l2_localizable__rt_pdelab.cc index 31d1a9911a568e617d58407d35cdd5c647f8324b..4d4b0c22d71311ef2a53c3cdc32a38edaeac3c5e 100644 --- a/dune/gdt/test/projections__l2_localizable__rt_pdelab.cc +++ b/dune/gdt/test/projections__l2_localizable__rt_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_RT_PDELAB , SPACES_RT_PDELAB_ALUGRID #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__lagrange__cg_fem.cc b/dune/gdt/test/projections__lagrange__cg_fem.cc index 37fb6cd525ce921cfe650d425836521dd22e7b27..b4d9252105244c7e3bdfe38a54737a8aa21edd22 100644 --- a/dune/gdt/test/projections__lagrange__cg_fem.cc +++ b/dune/gdt/test/projections__lagrange__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM(1) , SPACES_CG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(LagrangeProjectionOperatorTest, SpaceTypes); TYPED_TEST(LagrangeProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__lagrange__cg_pdelab.cc b/dune/gdt/test/projections__lagrange__cg_pdelab.cc index 6c8f3c3dd85ede79538e03cc961daaf1b5105eda..9b66c0ebf31f0aefd1b002833c41a881746b51a8 100644 --- a/dune/gdt/test/projections__lagrange__cg_pdelab.cc +++ b/dune/gdt/test/projections__lagrange__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB(1) , SPACES_CG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(LagrangeProjectionOperatorTest, SpaceTypes); TYPED_TEST(LagrangeProjectionOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__lagrange_localizable__cg_fem.cc b/dune/gdt/test/projections__lagrange_localizable__cg_fem.cc index e0cf37847086254f2f78b8642d8c864c4dbba392..2d6a451c7cefb66964baf8f5641a042abb910041 100644 --- a/dune/gdt/test/projections__lagrange_localizable__cg_fem.cc +++ b/dune/gdt/test/projections__lagrange_localizable__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM(1) , SPACES_CG_FEM_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(LagrangeProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(LagrangeProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__lagrange_localizable__cg_pdelab.cc b/dune/gdt/test/projections__lagrange_localizable__cg_pdelab.cc index a564fdc052e324ba558d3b73d27c9e60df4b7ea7..9688d074bafa623fd26af9541c6426c88a35db96 100644 --- a/dune/gdt/test/projections__lagrange_localizable__cg_pdelab.cc +++ b/dune/gdt/test/projections__lagrange_localizable__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB(1) , SPACES_CG_PDELAB_ALUGRID(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(LagrangeProjectionLocalizableOperatorTest, SpaceTypes); TYPED_TEST(LagrangeProjectionLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/projections__rt_pdelab.cc b/dune/gdt/test/projections__rt_pdelab.cc index 5e49dd1f41be068b1d03c37a1ac3efbd8ce0fdd9..fc98a75d573fdddb92be88bad5d5d5e1a5166012 100644 --- a/dune/gdt/test/projections__rt_pdelab.cc +++ b/dune/gdt/test/projections__rt_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_RT_PDELAB , SPACES_RT_PDELAB_ALUGRID #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProjectionTest, SpaceTypes); TYPED_TEST(ProjectionTest, produces_correct_results) diff --git a/dune/gdt/test/prolongations/l2-global.hh b/dune/gdt/test/prolongations/l2-global.hh index 7c68c75b31e6239b1919ff330b6d12b8a691e128..9c00347d7604fccbc9342947774100390374532e 100644 --- a/dune/gdt/test/prolongations/l2-global.hh +++ b/dune/gdt/test/prolongations/l2-global.hh @@ -46,9 +46,9 @@ struct L2GlobalProlongationLocalizableOperatorTest const auto& source = this->coarse_discrete_function_; auto& range = this->fine_discrete_function_; - auto DUNE_UNUSED(w_gv_w_oi) = make_global_l2_prolongation_localizable_operator(grid_view, source, range, 1); - auto DUNE_UNUSED(w_gv_wo_oi) = make_global_l2_prolongation_localizable_operator(grid_view, source, range); - auto DUNE_UNUSED(wo_gv_w_oi) = make_global_l2_prolongation_localizable_operator(source, range, 1); + auto DUNE_UNUSED(w_gv_w_oi) = make_global_l2_prolongation_localizable_operator(grid_view, source, range, 1); + auto DUNE_UNUSED(w_gv_wo_oi) = make_global_l2_prolongation_localizable_operator(grid_view, source, range); + auto DUNE_UNUSED(wo_gv_w_oi) = make_global_l2_prolongation_localizable_operator(source, range, 1); auto DUNE_UNUSED(wo_gv_wo_oi) = make_global_l2_prolongation_localizable_operator(source, range); } // ... constructible_by_factory(...) }; @@ -65,7 +65,7 @@ struct L2GlobalProlongationOperatorTest { this->prepare(tolerance); - auto grid_view = this->fine_space_.grid_view(); + auto grid_view = this->fine_space_.grid_view(); const auto& DUNE_UNUSED(source) = this->coarse_discrete_function_; auto& DUNE_UNUSED(range) = this->fine_discrete_function_; @@ -79,7 +79,7 @@ struct L2GlobalProlongationOperatorTest auto grid_view = this->fine_space_.grid_view(); - auto DUNE_UNUSED(w_over_integrate) = make_global_l2_prolongation_operator(grid_view, 1); + auto DUNE_UNUSED(w_over_integrate) = make_global_l2_prolongation_operator(grid_view, 1); auto DUNE_UNUSED(wo_over_integrate) = make_global_l2_prolongation_operator(grid_view); } // ... constructible_by_factory(...) }; diff --git a/dune/gdt/test/prolongations/l2-local.hh b/dune/gdt/test/prolongations/l2-local.hh index c8ef689b3cdad814e4aa1df37ab8feb7bcb80462..0d0422107a6a1f5e54b55eb3643f7df41bac8540 100644 --- a/dune/gdt/test/prolongations/l2-local.hh +++ b/dune/gdt/test/prolongations/l2-local.hh @@ -46,9 +46,9 @@ struct L2LocalProlongationLocalizableOperatorTest const auto& source = this->coarse_discrete_function_; auto& range = this->fine_discrete_function_; - auto DUNE_UNUSED(w_gv_w_oi) = make_local_l2_prolongation_localizable_operator(grid_view, source, range, 1); - auto DUNE_UNUSED(w_gv_wo_oi) = make_local_l2_prolongation_localizable_operator(grid_view, source, range); - auto DUNE_UNUSED(wo_gv_w_oi) = make_local_l2_prolongation_localizable_operator(source, range, 1); + auto DUNE_UNUSED(w_gv_w_oi) = make_local_l2_prolongation_localizable_operator(grid_view, source, range, 1); + auto DUNE_UNUSED(w_gv_wo_oi) = make_local_l2_prolongation_localizable_operator(grid_view, source, range); + auto DUNE_UNUSED(wo_gv_w_oi) = make_local_l2_prolongation_localizable_operator(source, range, 1); auto DUNE_UNUSED(wo_gv_wo_oi) = make_local_l2_prolongation_localizable_operator(source, range); } // ... constructible_by_factory(...) }; @@ -65,7 +65,7 @@ struct L2LocalProlongationOperatorTest { this->prepare(tolerance); - auto grid_view = this->fine_space_.grid_view(); + auto grid_view = this->fine_space_.grid_view(); const auto& DUNE_UNUSED(source) = this->coarse_discrete_function_; auto& DUNE_UNUSED(range) = this->fine_discrete_function_; @@ -79,7 +79,7 @@ struct L2LocalProlongationOperatorTest auto grid_view = this->fine_space_.grid_view(); - auto DUNE_UNUSED(w_over_integrate) = make_local_l2_prolongation_operator(grid_view, 1); + auto DUNE_UNUSED(w_over_integrate) = make_local_l2_prolongation_operator(grid_view, 1); auto DUNE_UNUSED(wo_over_integrate) = make_local_l2_prolongation_operator(grid_view); } // ... constructible_by_factory(...) }; diff --git a/dune/gdt/test/prolongations/l2.hh b/dune/gdt/test/prolongations/l2.hh index a46464beffce95268bcece3ef34687c5e37eedff..f4cea699e30940b3068826722c05179e37a1f859 100644 --- a/dune/gdt/test/prolongations/l2.hh +++ b/dune/gdt/test/prolongations/l2.hh @@ -46,9 +46,9 @@ struct L2ProlongationLocalizableOperatorTest const auto& source = this->coarse_discrete_function_; auto& range = this->fine_discrete_function_; - auto DUNE_UNUSED(w_gv_w_oi) = make_global_l2_prolongation_localizable_operator(grid_view, source, range, 1); - auto DUNE_UNUSED(w_gv_wo_oi) = make_global_l2_prolongation_localizable_operator(grid_view, source, range); - auto DUNE_UNUSED(wo_gv_w_oi) = make_global_l2_prolongation_localizable_operator(source, range, 1); + auto DUNE_UNUSED(w_gv_w_oi) = make_global_l2_prolongation_localizable_operator(grid_view, source, range, 1); + auto DUNE_UNUSED(w_gv_wo_oi) = make_global_l2_prolongation_localizable_operator(grid_view, source, range); + auto DUNE_UNUSED(wo_gv_w_oi) = make_global_l2_prolongation_localizable_operator(source, range, 1); auto DUNE_UNUSED(wo_gv_wo_oi) = make_global_l2_prolongation_localizable_operator(source, range); } // ... constructible_by_factory(...) }; @@ -64,7 +64,7 @@ struct L2ProlongationOperatorTest : public ProlongationOperatorBase<SpaceType, S { this->prepare(tolerance); - auto grid_view = this->fine_space_.grid_view(); + auto grid_view = this->fine_space_.grid_view(); const auto& DUNE_UNUSED(source) = this->coarse_discrete_function_; auto& DUNE_UNUSED(range) = this->fine_discrete_function_; @@ -78,7 +78,7 @@ struct L2ProlongationOperatorTest : public ProlongationOperatorBase<SpaceType, S auto grid_view = this->fine_space_.grid_view(); - auto DUNE_UNUSED(w_over_integrate) = make_l2_prolongation_operator(grid_view, 1); + auto DUNE_UNUSED(w_over_integrate) = make_l2_prolongation_operator(grid_view, 1); auto DUNE_UNUSED(wo_over_integrate) = make_l2_prolongation_operator(grid_view); } // ... constructible_by_factory(...) diff --git a/dune/gdt/test/prolongations/lagrange.hh b/dune/gdt/test/prolongations/lagrange.hh index 0f1d1ecec6bdd0dea77a5a4dbe5c67decc77e4d5..962e6595df30adf1f23ec62f5e05b692e986a4dd 100644 --- a/dune/gdt/test/prolongations/lagrange.hh +++ b/dune/gdt/test/prolongations/lagrange.hh @@ -45,7 +45,7 @@ struct LagrangeProlongationLocalizableOperatorTest const auto& source = this->coarse_discrete_function_; auto& range = this->fine_discrete_function_; - auto DUNE_UNUSED(w_gv) = make_lagrange_prolongation_localizable_operator(grid_view, source, range); + auto DUNE_UNUSED(w_gv) = make_lagrange_prolongation_localizable_operator(grid_view, source, range); auto DUNE_UNUSED(wo_gv) = make_lagrange_prolongation_localizable_operator(source, range); } // ... constructible_by_factory(...) }; diff --git a/dune/gdt/test/prolongations__cg_fem.cc b/dune/gdt/test/prolongations__cg_fem.cc index 3461dd767f0da28f24abfb0fdff82942be56a403..ce334bed111b24a79598a62da65ed27e0edcef9e 100644 --- a/dune/gdt/test/prolongations__cg_fem.cc +++ b/dune/gdt/test/prolongations__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM_LEVEL(1) , SPACES_CG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProlongationTest, SpaceTypes); TYPED_TEST(ProlongationTest, produces_correct_results) diff --git a/dune/gdt/test/prolongations__cg_pdelab.cc b/dune/gdt/test/prolongations__cg_pdelab.cc index c6a7f6aaa05bb13e7636f51e2c6d64dff341c2a1..de570ab52f1cfd51ea22b14778f7f9b68baf0c91 100644 --- a/dune/gdt/test/prolongations__cg_pdelab.cc +++ b/dune/gdt/test/prolongations__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB_LEVEL(1) , SPACES_CG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProlongationTest, SpaceTypes); TYPED_TEST(ProlongationTest, produces_correct_results) diff --git a/dune/gdt/test/prolongations__dg_fem.cc b/dune/gdt/test/prolongations__dg_fem.cc index f78446f5d0da56c5fc0618e3e0d1853698a55b3c..2441dfca2cefed31aac182e544acab983a1cad6e 100644 --- a/dune/gdt/test/prolongations__dg_fem.cc +++ b/dune/gdt/test/prolongations__dg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_FEM_LEVEL(1) , SPACES_DG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProlongationTest, SpaceTypes); TYPED_TEST(ProlongationTest, produces_correct_results) diff --git a/dune/gdt/test/prolongations__dg_pdelab.cc b/dune/gdt/test/prolongations__dg_pdelab.cc index c3b94204c4b6febc9c39151cfc01b9339cff49e9..b83e9425fda296af842922afd4053d452a1802d8 100644 --- a/dune/gdt/test/prolongations__dg_pdelab.cc +++ b/dune/gdt/test/prolongations__dg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_PDELAB_LEVEL(1) , SPACES_DG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProlongationTest, SpaceTypes); TYPED_TEST(ProlongationTest, produces_correct_results) diff --git a/dune/gdt/test/prolongations__fv_default.cc b/dune/gdt/test/prolongations__fv_default.cc index 0439c64f7de4b87ab41b19d31ec3f57ba71520dc..a3bac1825d54884ceabdfbe2e08e8efab12f3dea 100644 --- a/dune/gdt/test/prolongations__fv_default.cc +++ b/dune/gdt/test/prolongations__fv_default.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACE_FV_SGRID_LEVEL(1, 1), SPACE_FV_SGRID_LEVEL(2, 1), S SPACE_FV_ALUCONFORMGRID_LEVEL(2, 1), SPACE_FV_ALUCONFORMGRID_LEVEL(3, 1), SPACE_FV_ALUCUBEGRID_LEVEL(2, 1), SPACE_FV_ALUCUBEGRID_LEVEL(3, 1) #endif // HAVE_DUNE_ALUGRID - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProlongationTest, SpaceTypes); TYPED_TEST(ProlongationTest, produces_correct_results) diff --git a/dune/gdt/test/prolongations__l2__cg_fem.cc b/dune/gdt/test/prolongations__l2__cg_fem.cc index 9f9745889befe08ac530014126e85e30da4ebe40..c395d45348440a422b7a61f8f25eb1fe56ef11cc 100644 --- a/dune/gdt/test/prolongations__l2__cg_fem.cc +++ b/dune/gdt/test/prolongations__l2__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM_LEVEL(1) , SPACES_CG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2__cg_pdelab.cc b/dune/gdt/test/prolongations__l2__cg_pdelab.cc index f5ccae2e6598266567b584655bcef0817767844c..fbc0fc76a0ead42a165b77416eda1b33d689957d 100644 --- a/dune/gdt/test/prolongations__l2__cg_pdelab.cc +++ b/dune/gdt/test/prolongations__l2__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB_LEVEL(1) , SPACES_CG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2__dg_fem.cc b/dune/gdt/test/prolongations__l2__dg_fem.cc index ef954979374017c184f0708f5489e31fd62a4439..15de5efb3ab57062310bcb6457fd1d415d9309e9 100644 --- a/dune/gdt/test/prolongations__l2__dg_fem.cc +++ b/dune/gdt/test/prolongations__l2__dg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_FEM_LEVEL(1) , SPACES_DG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2__dg_pdelab.cc b/dune/gdt/test/prolongations__l2__dg_pdelab.cc index 4a9ceff7eea4fcceb7d7114901f6454ab0549649..7b04ac9f50a0234ffc3b4002a10428972877f49e 100644 --- a/dune/gdt/test/prolongations__l2__dg_pdelab.cc +++ b/dune/gdt/test/prolongations__l2__dg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_PDELAB_LEVEL(1) , SPACES_DG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2__fv_default.cc b/dune/gdt/test/prolongations__l2__fv_default.cc index 171ab601f861f6745301b6df73718465c04c5db5..c3c1c9a304ae3ea4069d4ba6af6534a1e0498311 100644 --- a/dune/gdt/test/prolongations__l2__fv_default.cc +++ b/dune/gdt/test/prolongations__l2__fv_default.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACE_FV_SGRID_LEVEL(1, 1), SPACE_FV_SGRID_LEVEL(2, 1), S SPACE_FV_ALUCONFORMGRID_LEVEL(2, 1), SPACE_FV_ALUCONFORMGRID_LEVEL(3, 1), SPACE_FV_ALUCUBEGRID_LEVEL(2, 1), SPACE_FV_ALUCUBEGRID_LEVEL(3, 1) #endif // HAVE_DUNE_ALUGRID - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2__rt_pdelab.cc b/dune/gdt/test/prolongations__l2__rt_pdelab.cc index 17a4559f05b604ba32c9ba3ae07f567d293d27f4..00a58a560bb2e5025c2263236cb39f334862fa64 100644 --- a/dune/gdt/test/prolongations__l2__rt_pdelab.cc +++ b/dune/gdt/test/prolongations__l2__rt_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_RT_PDELAB_LEVEL , SPACES_RT_PDELAB_ALUGRID_LEVEL #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_global__cg_fem.cc b/dune/gdt/test/prolongations__l2_global__cg_fem.cc index 51a1cb4ca0d7069e7a26f5361a141420c5fce0ca..a9e227e0452552392704482e0a76c5d3c689651b 100644 --- a/dune/gdt/test/prolongations__l2_global__cg_fem.cc +++ b/dune/gdt/test/prolongations__l2_global__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM_LEVEL(1) , SPACES_CG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2GlobalProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2GlobalProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_global__cg_pdelab.cc b/dune/gdt/test/prolongations__l2_global__cg_pdelab.cc index df3f5602028ecef2667e1181b113886bef93b5e3..80cbb8b5194dafd15ca11ca18780ae8a6b73d953 100644 --- a/dune/gdt/test/prolongations__l2_global__cg_pdelab.cc +++ b/dune/gdt/test/prolongations__l2_global__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB_LEVEL(1) , SPACES_CG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2GlobalProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2GlobalProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_global_localizable__cg_fem.cc b/dune/gdt/test/prolongations__l2_global_localizable__cg_fem.cc index 1549799ca276457db2aa6fa14471deb673d78dc0..63be97149eb01f0ae3d8996457169acde2ed2778 100644 --- a/dune/gdt/test/prolongations__l2_global_localizable__cg_fem.cc +++ b/dune/gdt/test/prolongations__l2_global_localizable__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM_LEVEL(1) , SPACES_CG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2GlobalProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2GlobalProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_global_localizable__cg_pdelab.cc b/dune/gdt/test/prolongations__l2_global_localizable__cg_pdelab.cc index 44f7d10c54fb0fff142d4039774f2e2692b9000e..0c96a32806cce21b9690b001ee716c26335c60f8 100644 --- a/dune/gdt/test/prolongations__l2_global_localizable__cg_pdelab.cc +++ b/dune/gdt/test/prolongations__l2_global_localizable__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB_LEVEL(1) , SPACES_CG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2GlobalProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2GlobalProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_local__dg_fem.cc b/dune/gdt/test/prolongations__l2_local__dg_fem.cc index 19ace1dabe3df6e65339b3933422db4057650f5e..1310802c27bd7bd78bb15ed16125ccb3ea3d0cd7 100644 --- a/dune/gdt/test/prolongations__l2_local__dg_fem.cc +++ b/dune/gdt/test/prolongations__l2_local__dg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_FEM_LEVEL(1) , SPACES_DG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_local__dg_pdelab.cc b/dune/gdt/test/prolongations__l2_local__dg_pdelab.cc index 09b471477131ec73c03e6224bbdd2eff71cd6325..4971fb4894199b904115d8fb9b592f4dd6ce9cfe 100644 --- a/dune/gdt/test/prolongations__l2_local__dg_pdelab.cc +++ b/dune/gdt/test/prolongations__l2_local__dg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_PDELAB_LEVEL(1) , SPACES_DG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_local__fv_default.cc b/dune/gdt/test/prolongations__l2_local__fv_default.cc index 563d7f712a13ac611e858eb7efa61de95ef5c735..75488d628d3b40d13769ad379a36af9b552ed4d9 100644 --- a/dune/gdt/test/prolongations__l2_local__fv_default.cc +++ b/dune/gdt/test/prolongations__l2_local__fv_default.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACE_FV_SGRID_LEVEL(1, 1), SPACE_FV_SGRID_LEVEL(2, 1), S SPACE_FV_ALUCONFORMGRID_LEVEL(2, 1), SPACE_FV_ALUCONFORMGRID_LEVEL(3, 1), SPACE_FV_ALUCUBEGRID_LEVEL(2, 1), SPACE_FV_ALUCUBEGRID_LEVEL(3, 1) #endif // HAVE_DUNE_ALUGRID - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_local__rt_pdelab.cc b/dune/gdt/test/prolongations__l2_local__rt_pdelab.cc index 4a77e4b9d5119964bd979d7fa2b7e6991cdc080c..f04bc2b35dedb430500907b077c25fee4c7a6c67 100644 --- a/dune/gdt/test/prolongations__l2_local__rt_pdelab.cc +++ b/dune/gdt/test/prolongations__l2_local__rt_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_RT_PDELAB_LEVEL , SPACES_RT_PDELAB_ALUGRID_LEVEL #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProlongationOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_local_localizable__dg_fem.cc b/dune/gdt/test/prolongations__l2_local_localizable__dg_fem.cc index c0f68878b1fa6e433f03bf7745d30583f6cd095d..1f6ee9810646766a44cd5d7010df30825536f019 100644 --- a/dune/gdt/test/prolongations__l2_local_localizable__dg_fem.cc +++ b/dune/gdt/test/prolongations__l2_local_localizable__dg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_FEM_LEVEL(1) , SPACES_DG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_local_localizable__dg_pdelab.cc b/dune/gdt/test/prolongations__l2_local_localizable__dg_pdelab.cc index cadc069ba725f1b58c1aafba72232ef543144f8e..c8284cfd191bd2e4656a6bf4691ff7d5540821c8 100644 --- a/dune/gdt/test/prolongations__l2_local_localizable__dg_pdelab.cc +++ b/dune/gdt/test/prolongations__l2_local_localizable__dg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_PDELAB_LEVEL(1) , SPACES_DG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_local_localizable__fv_default.cc b/dune/gdt/test/prolongations__l2_local_localizable__fv_default.cc index 0268ed2574fd21511e4f73db1bcfa90aed3b47b7..c5c700d19898a6a8578ca2eb1b1a64bb10ad891d 100644 --- a/dune/gdt/test/prolongations__l2_local_localizable__fv_default.cc +++ b/dune/gdt/test/prolongations__l2_local_localizable__fv_default.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACE_FV_SGRID_LEVEL(1, 1), SPACE_FV_SGRID_LEVEL(2, 1), S SPACE_FV_ALUCONFORMGRID_LEVEL(2, 1), SPACE_FV_ALUCONFORMGRID_LEVEL(3, 1), SPACE_FV_ALUCUBEGRID_LEVEL(2, 1), SPACE_FV_ALUCUBEGRID_LEVEL(3, 1) #endif // HAVE_DUNE_ALUGRID - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_local_localizable__rt_pdelab.cc b/dune/gdt/test/prolongations__l2_local_localizable__rt_pdelab.cc index 453853cad9ae57452225da0a0523588034224be3..b5431758126a93cd17d5515a4f70b1fc1491e4fc 100644 --- a/dune/gdt/test/prolongations__l2_local_localizable__rt_pdelab.cc +++ b/dune/gdt/test/prolongations__l2_local_localizable__rt_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_RT_PDELAB_LEVEL , SPACES_RT_PDELAB_ALUGRID_LEVEL #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2LocalProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2LocalProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_localizable__cg_fem.cc b/dune/gdt/test/prolongations__l2_localizable__cg_fem.cc index 52b3f314939be21f21273bef71c80213d0b29977..4ddc1d1b190ea4f2e99523d5c7a90cd52b93f4a8 100644 --- a/dune/gdt/test/prolongations__l2_localizable__cg_fem.cc +++ b/dune/gdt/test/prolongations__l2_localizable__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM_LEVEL(1) , SPACES_CG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_localizable__cg_pdelab.cc b/dune/gdt/test/prolongations__l2_localizable__cg_pdelab.cc index f545e9b11819a2390340caa0798e4b8d33190c4f..618239e9a4ee27388934d16fc01c50cbbd741136 100644 --- a/dune/gdt/test/prolongations__l2_localizable__cg_pdelab.cc +++ b/dune/gdt/test/prolongations__l2_localizable__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB_LEVEL(1) , SPACES_CG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_localizable__dg_fem.cc b/dune/gdt/test/prolongations__l2_localizable__dg_fem.cc index 7e50fb4f4dd6f3416b74dfe067aac0895151afa9..c10b6513f3acd9ce5aae208d3c3de3e035a6d48f 100644 --- a/dune/gdt/test/prolongations__l2_localizable__dg_fem.cc +++ b/dune/gdt/test/prolongations__l2_localizable__dg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_FEM_LEVEL(1) , SPACES_DG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_localizable__dg_pdelab.cc b/dune/gdt/test/prolongations__l2_localizable__dg_pdelab.cc index e701f9c7d923f9d259be528432106992b6ab1e6f..9cdaf760336cf57fcee94a38033c89b9fa15c30b 100644 --- a/dune/gdt/test/prolongations__l2_localizable__dg_pdelab.cc +++ b/dune/gdt/test/prolongations__l2_localizable__dg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_DG_PDELAB_LEVEL(1) , SPACES_DG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_localizable__fv_default.cc b/dune/gdt/test/prolongations__l2_localizable__fv_default.cc index e064303a07a20e194b0f8ffc7b5386dfc1ba9faa..7c10935b759fd52d317f5bee73e52ff6661282a0 100644 --- a/dune/gdt/test/prolongations__l2_localizable__fv_default.cc +++ b/dune/gdt/test/prolongations__l2_localizable__fv_default.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACE_FV_SGRID_LEVEL(1, 1), SPACE_FV_SGRID_LEVEL(2, 1), S SPACE_FV_ALUCONFORMGRID_LEVEL(2, 1), SPACE_FV_ALUCONFORMGRID_LEVEL(3, 1), SPACE_FV_ALUCUBEGRID_LEVEL(2, 1), SPACE_FV_ALUCUBEGRID_LEVEL(3, 1) #endif // HAVE_DUNE_ALUGRID - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__l2_localizable__rt_pdelab.cc b/dune/gdt/test/prolongations__l2_localizable__rt_pdelab.cc index 4f27ecc3ddb23779cda0d81e365b93e890b450b5..a0ee7b1c1514c0ce9f8b56950b053f17b2ae390c 100644 --- a/dune/gdt/test/prolongations__l2_localizable__rt_pdelab.cc +++ b/dune/gdt/test/prolongations__l2_localizable__rt_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_RT_PDELAB_LEVEL , SPACES_RT_PDELAB_ALUGRID_LEVEL #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(L2ProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(L2ProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__lagrange__cg_fem.cc b/dune/gdt/test/prolongations__lagrange__cg_fem.cc index 7adc621018cbc30817e816e9a95123db8caded6e..95ba2ecd0784b4aa3abb4b88b0d079817b0fab26 100644 --- a/dune/gdt/test/prolongations__lagrange__cg_fem.cc +++ b/dune/gdt/test/prolongations__lagrange__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM_LEVEL(1) , SPACES_CG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(LagrangeProlongationOperatorTest, SpaceTypes); TYPED_TEST(LagrangeProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__lagrange__cg_pdelab.cc b/dune/gdt/test/prolongations__lagrange__cg_pdelab.cc index 541721c01c883a841356a3b718ea0b3cf83ea06b..47451512e53f1f0b2b210d2fdb19d3a5317242fa 100644 --- a/dune/gdt/test/prolongations__lagrange__cg_pdelab.cc +++ b/dune/gdt/test/prolongations__lagrange__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB_LEVEL(1) , SPACES_CG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(LagrangeProlongationOperatorTest, SpaceTypes); TYPED_TEST(LagrangeProlongationOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__lagrange_localizable__cg_fem.cc b/dune/gdt/test/prolongations__lagrange_localizable__cg_fem.cc index 0e6c87cef8805925e9884ae1ffc5cd9a93883a2b..22d12c382d04e348aea8dcf779420139e999e632 100644 --- a/dune/gdt/test/prolongations__lagrange_localizable__cg_fem.cc +++ b/dune/gdt/test/prolongations__lagrange_localizable__cg_fem.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_FEM_LEVEL(1) , SPACES_CG_FEM_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(LagrangeProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(LagrangeProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__lagrange_localizable__cg_pdelab.cc b/dune/gdt/test/prolongations__lagrange_localizable__cg_pdelab.cc index 906d80e7125873f3dd4b52aa171f73e80e118bff..f68c5026aa3d6bc557b090cd3e4e85811e3afb00 100644 --- a/dune/gdt/test/prolongations__lagrange_localizable__cg_pdelab.cc +++ b/dune/gdt/test/prolongations__lagrange_localizable__cg_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_CG_PDELAB_LEVEL(1) , SPACES_CG_PDELAB_ALUGRID_LEVEL(1) #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(LagrangeProlongationLocalizableOperatorTest, SpaceTypes); TYPED_TEST(LagrangeProlongationLocalizableOperatorTest, constructible_by_ctor) diff --git a/dune/gdt/test/prolongations__rt_pdelab.cc b/dune/gdt/test/prolongations__rt_pdelab.cc index 58a667629b12898951421fa5dc819e28291dc5ba..252189c8fbf949685d09a6cea35b1943c7b4f5ae 100644 --- a/dune/gdt/test/prolongations__rt_pdelab.cc +++ b/dune/gdt/test/prolongations__rt_pdelab.cc @@ -20,7 +20,8 @@ typedef testing::Types<SPACES_RT_PDELAB_LEVEL , SPACES_RT_PDELAB_ALUGRID_LEVEL #endif - > SpaceTypes; + > + SpaceTypes; TYPED_TEST_CASE(ProlongationTest, SpaceTypes); TYPED_TEST(ProlongationTest, produces_correct_results) diff --git a/dune/gdt/test/spaces/base.hh b/dune/gdt/test/spaces/base.hh index aa78399f1078a0e0d513974e58e7a5d47db49843..8f73612ee18fda55d85f5844c4080a10b973ec80 100644 --- a/dune/gdt/test/spaces/base.hh +++ b/dune/gdt/test/spaces/base.hh @@ -168,7 +168,7 @@ public: D_PatternType d_pattern_face = space_.compute_face_pattern(); D_PatternType d_pattern_face_view = space_.compute_face_pattern(d_grid_view); D_PatternType d_pattern_face_other = space_.compute_face_pattern(space_); - D_PatternType d_pattern_face_view_other = space_.compute_face_pattern(d_grid_view, space_); + D_PatternType d_pattern_face_view_other = space_.compute_face_pattern(d_grid_view, space_); EXPECT_EQ(d_pattern, d_pattern_other); EXPECT_EQ(d_pattern, d_pattern_view); EXPECT_EQ(d_pattern, d_pattern_view_other); @@ -202,7 +202,7 @@ public: I_PatternType i_pattern_face = i_space.compute_face_pattern(); I_PatternType i_pattern_face_view = i_space.compute_face_pattern(i_grid_view); I_PatternType i_pattern_face_other = i_space.compute_face_pattern(i_space); - I_PatternType i_pattern_face_view_other = i_space.compute_face_pattern(i_grid_view, i_space); + I_PatternType i_pattern_face_view_other = i_space.compute_face_pattern(i_grid_view, i_space); EXPECT_EQ(&i_backend, &d_backend); EXPECT_EQ(&i_mapper, &d_mapper); EXPECT_EQ(&i_grid_view, &d_grid_view); @@ -229,11 +229,11 @@ public: const D_EntityType& entity = *entity_it; // * as the derived type D_BaseFunctionSetType d_base_function_set = space_.base_function_set(entity); - size_t d_bfs_size = d_base_function_set.size(); + size_t d_bfs_size = d_base_function_set.size(); EXPECT_EQ(d_bfs_size, d_mapper.numDofs(entity)); // * as the interface type I_BaseFunctionSetType i_base_function_set = i_space.base_function_set(entity); - size_t i_bfs_size = i_base_function_set.size(); + size_t i_bfs_size = i_base_function_set.size(); EXPECT_EQ(d_bfs_size, i_bfs_size); } // walk the grid } // ... fulfills_interface() @@ -242,7 +242,7 @@ public: { SpaceType foop(space_); auto DUNE_UNUSED(aa) = foop.mapper().size(); - SpaceType cp = DerivedHolder<SpaceType, ProviderType>(grid_provider_).space(); + SpaceType cp = DerivedHolder<SpaceType, ProviderType>(grid_provider_).space(); auto DUNE_UNUSED(bb) = cp.mapper().size(); } // ... check_for_correct_copy() @@ -277,7 +277,7 @@ public: const InterfaceType& i_mapper = static_cast<const InterfaceType&>(d_mapper); const D_BackendType& i_backend = i_mapper.backend(); size_t i_size = i_mapper.size(); - size_t i_maxNumDofs = i_mapper.maxNumDofs(); + size_t i_maxNumDofs = i_mapper.maxNumDofs(); EXPECT_EQ(&i_backend, &d_backend); EXPECT_EQ(i_size, d_size); EXPECT_EQ(i_maxNumDofs, d_maxNumDofs); @@ -349,7 +349,8 @@ public: d_dimDomain, D_RangeFieldType, d_dimRange, - d_dimRangeCols> InterfaceType; + d_dimRangeCols> + InterfaceType; typedef typename InterfaceType::derived_type derived_type; typedef typename InterfaceType::BackendType I_BackendType; typedef typename InterfaceType::EntityType I_EntityType; @@ -391,7 +392,7 @@ public: // the size has already been checked in fulfills_interface() above // * as the interface InterfaceType& i_base_function_set = static_cast<InterfaceType&>(d_base_function_set); - const I_BackendType& i_backend = i_base_function_set.backend(); + const I_BackendType& i_backend = i_base_function_set.backend(); EXPECT_EQ(&d_backend, &i_backend); size_t i_order = i_base_function_set.order(); EXPECT_EQ(i_order, d_order); diff --git a/dune/gdt/test/spaces/cg.hh b/dune/gdt/test/spaces/cg.hh index 55ffa22c3d8e5096382ad192fbdfeb5e1b3a803a..8468ecb2ef2454ee71d5dc254d2c4be665e0bde6 100644 --- a/dune/gdt/test/spaces/cg.hh +++ b/dune/gdt/test/spaces/cg.hh @@ -47,7 +47,7 @@ struct P1Q1_CG_Space : public SpaceBase<SpaceType> { std::vector<DomainFieldType> ret(dimDomain, DomainFieldType(0)); for (size_t ii = 0; ii < dimDomain; ++ii) - ret[ii] = source[ii]; + ret[ii] = source[ii]; return ret; } @@ -90,16 +90,16 @@ struct P1Q1_CG_Space : public SpaceBase<SpaceType> for (auto entity_it = this->space_.grid_view().template begin<0>(); entity_it != entity_end_it; ++entity_it) { const auto& entity = *entity_it; for (auto cc : DSC::valueRange(entity.template count<dimDomain>())) { - const auto vertex_ptr = entity.template subEntity<dimDomain>(cc); - const DomainType vertex = vertex_ptr->geometry().center(); + const auto vertex_ptr = entity.template subEntity<dimDomain>(cc); + const DomainType vertex = vertex_ptr->geometry().center(); vertex_to_indices_map[convert_vector(vertex)] = std::set<size_t>(); } } // walk the grid again to find all DoF ids - auto functor = [&](const typename GridProviderType::EntityType& entity) { + auto functor = [&](const typename GridProviderType::EntityType& entity) { const size_t num_vertices = boost::numeric_cast<size_t>(entity.template count<dimDomain>()); - const auto basis = this->space_.base_function_set(entity); + const auto basis = this->space_.base_function_set(entity); EXPECT_EQ(basis.size(), num_vertices); for (size_t cc = 0; cc < num_vertices; ++cc) { const auto vertex_ptr = entity.template subEntity<dimDomain>(boost::numeric_cast<int>(cc)); diff --git a/dune/gdt/test/spaces/dg.hh b/dune/gdt/test/spaces/dg.hh index 5922799aac8225ece2ea9dabbf0a81f975bef0cd..1eba8dc0076191fbeb2492c16deeccb16ab66e61 100644 --- a/dune/gdt/test/spaces/dg.hh +++ b/dune/gdt/test/spaces/dg.hh @@ -37,7 +37,7 @@ struct P1Q1_DG_Space : public SpaceBase<SpaceType> { std::vector<DomainFieldType> ret(dimDomain, DomainFieldType(0)); for (size_t ii = 0; ii < dimDomain; ++ii) - ret[ii] = source[ii]; + ret[ii] = source[ii]; return ret; } @@ -50,8 +50,8 @@ struct P1Q1_DG_Space : public SpaceBase<SpaceType> for (auto entity_it = this->space_.grid_view().template begin<0>(); entity_it != entity_end_it; ++entity_it) { const auto& entity = *entity_it; for (auto cc : DSC::valueRange(entity.template count<dimDomain>())) { - const auto vertex_ptr = entity.template subEntity<dimDomain>(cc); - const DomainType vertex = vertex_ptr->geometry().center(); + const auto vertex_ptr = entity.template subEntity<dimDomain>(cc); + const DomainType vertex = vertex_ptr->geometry().center(); vertex_to_indices_map[convert_vector(vertex)].first = std::set<size_t>(); ++vertex_to_indices_map[convert_vector(vertex)].second; } @@ -60,7 +60,7 @@ struct P1Q1_DG_Space : public SpaceBase<SpaceType> for (auto entity_it = this->space_.grid_view().template begin<0>(); entity_it != entity_end_it; ++entity_it) { const auto& entity = *entity_it; const size_t num_vertices = boost::numeric_cast<size_t>(entity.template count<dimDomain>()); - const auto basis = this->space_.base_function_set(entity); + const auto basis = this->space_.base_function_set(entity); EXPECT_EQ(basis.size(), num_vertices); for (size_t cc = 0; cc < num_vertices; ++cc) { const auto vertex_ptr = entity.template subEntity<dimDomain>(boost::numeric_cast<int>(cc)); @@ -109,7 +109,7 @@ struct P1Q1_DG_Space : public SpaceBase<SpaceType> for (const auto& entry : vertex_to_indices_map) { const auto vertex_ids = entry.second.first; size_t number_of_associated_DoF_ids = vertex_ids.size(); - size_t number_of_adjacent_entitys = entry.second.second; + size_t number_of_adjacent_entitys = entry.second.second; EXPECT_EQ(number_of_associated_DoF_ids, number_of_adjacent_entitys); } } // ... maps_correctly() diff --git a/dune/gdt/test/spaces__cg__fem.cc b/dune/gdt/test/spaces__cg__fem.cc index 0e97939848e14712aebf5309235d46a150bcebab..de5669d1d02e61b7b412a151468e8e5ed2723af3 100644 --- a/dune/gdt/test/spaces__cg__fem.cc +++ b/dune/gdt/test/spaces__cg__fem.cc @@ -19,7 +19,8 @@ typedef testing::Types<SPACES_CG_FEM(1) , SPACES_CG_FEM_ALUGRID(1) #endif - > CG_Spaces_Fem; + > + CG_Spaces_Fem; TYPED_TEST_CASE(CG_Space, CG_Spaces_Fem); TYPED_TEST(CG_Space, fulfills_interface) @@ -44,7 +45,8 @@ typedef testing::Types<SPACES_CG_FEM(1) , SPACES_CG_FEM_ALUGRID(1) #endif - > P1Q1_CG_Spaces_Fem; + > + P1Q1_CG_Spaces_Fem; TYPED_TEST_CASE(P1Q1_CG_Space, P1Q1_CG_Spaces_Fem); TYPED_TEST(P1Q1_CG_Space, fulfills_continuous_interface) diff --git a/dune/gdt/test/spaces__cg__pdelab.cc b/dune/gdt/test/spaces__cg__pdelab.cc index 193979fa746cdd0d6e7ee28c046c53525bf865c7..c32f0ae7cd97fdd56ab36152a81d3aa69b1571d1 100644 --- a/dune/gdt/test/spaces__cg__pdelab.cc +++ b/dune/gdt/test/spaces__cg__pdelab.cc @@ -19,7 +19,8 @@ typedef testing::Types<SPACES_CG_PDELAB(1) , SPACES_CG_PDELAB_ALUGRID(1) #endif - > CG_Spaces_Pdelab; + > + CG_Spaces_Pdelab; TYPED_TEST_CASE(CG_Space, CG_Spaces_Pdelab); TYPED_TEST(CG_Space, fulfills_interface) @@ -46,7 +47,8 @@ typedef testing::Types<SPACES_CG_PDELAB(1) , SPACES_CG_PDELAB_ALUGRID(1) #endif - > P1Q1_CG_Spaces_Pdelab; + > + P1Q1_CG_Spaces_Pdelab; TYPED_TEST_CASE(P1Q1_CG_Space, P1Q1_CG_Spaces_Pdelab); TYPED_TEST(P1Q1_CG_Space, fulfills_continuous_interface) diff --git a/dune/gdt/test/spaces__dg__fem.cc b/dune/gdt/test/spaces__dg__fem.cc index 70ea3c1ecacab5f80ded0d90e4f1e46e3cee4d41..4673bdb083a9eea4bc2bba04e0fe3d90c753678a 100644 --- a/dune/gdt/test/spaces__dg__fem.cc +++ b/dune/gdt/test/spaces__dg__fem.cc @@ -27,7 +27,8 @@ typedef testing::Types<SPACES_DG_FEM(1) SPACES_DG_FEM_ALUGRID(2) #endif #endif - > DG_Spaces_Fem; + > + DG_Spaces_Fem; TYPED_TEST_CASE(DG_Space, DG_Spaces_Fem); TYPED_TEST(DG_Space, fulfills_interface) @@ -68,7 +69,8 @@ typedef testing::Types<SPACES_DG_FEM(1) , SPACES_DG_FEM_ALUGRID(1) #endif - > P1Q1_DG_Spaces_Fem; + > + P1Q1_DG_Spaces_Fem; TYPED_TEST_CASE(P1Q1_DG_Space, P1Q1_DG_Spaces_Fem); TYPED_TEST(P1Q1_DG_Space, maps_correctly) diff --git a/dune/gdt/test/spaces__dg__pdelab.cc b/dune/gdt/test/spaces__dg__pdelab.cc index 22abea0466c66317658c3d9292c51d3800b55453..9647e7c8ae77464973275f2fcb4391d18fc7d733 100644 --- a/dune/gdt/test/spaces__dg__pdelab.cc +++ b/dune/gdt/test/spaces__dg__pdelab.cc @@ -19,7 +19,8 @@ typedef testing::Types<SPACES_DG_PDELAB(1) , SPACES_DG_PDELAB_ALUGRID(1) #endif - > DG_Spaces_Pdelab; + > + DG_Spaces_Pdelab; TYPED_TEST_CASE(DG_Space, DG_Spaces_Pdelab); TYPED_TEST(DG_Space, fulfills_interface) @@ -45,7 +46,8 @@ typedef testing::Types<SPACES_DG_PDELAB(1) , SPACES_DG_PDELAB_ALUGRID(1) #endif - > P1Q1_DG_Spaces_Pdelab; + > + P1Q1_DG_Spaces_Pdelab; TYPED_TEST_CASE(P1Q1_DG_Space, P1Q1_DG_Spaces_Pdelab); TYPED_TEST(P1Q1_DG_Space, maps_correctly) diff --git a/dune/gdt/test/spaces__fv__default.cc b/dune/gdt/test/spaces__fv__default.cc index 4eda9770abe7e08f7158a4c2a0dce9a6213d3e3a..e7a17ee5bd0331a1b4403a7ee872fa95389179f4 100644 --- a/dune/gdt/test/spaces__fv__default.cc +++ b/dune/gdt/test/spaces__fv__default.cc @@ -18,7 +18,8 @@ typedef testing::Types<SPACES_FV , SPACES_FV_ALUGRID #endif - > FV_Spaces; + > + FV_Spaces; TYPED_TEST_CASE(FV_Space, FV_Spaces); TYPED_TEST(FV_Space, fulfills_interface) diff --git a/dune/gdt/test/spaces__rt__pdelab.cc b/dune/gdt/test/spaces__rt__pdelab.cc index aa6d0bcf6d6dd8a8defb3689426a4298de2f38e8..1f783270daca64cd65997fb7485889f167013234 100644 --- a/dune/gdt/test/spaces__rt__pdelab.cc +++ b/dune/gdt/test/spaces__rt__pdelab.cc @@ -22,7 +22,8 @@ typedef testing::Types<SPACES_RT_PDELAB , SPACES_RT_PDELAB_ALUGRID #endif - > RT_Spaces; + > + RT_Spaces; TYPED_TEST_CASE(RT_Space, RT_Spaces); TYPED_TEST(RT_Space, fulfills_interface) diff --git a/dune/gdt/test/stationary-eocstudy.hh b/dune/gdt/test/stationary-eocstudy.hh index f4cc83e77df88cfe3e9112989769f80e762cca68..3bbc5152a2d69967bc58d3d0722f328dcdb7f8ec 100644 --- a/dune/gdt/test/stationary-eocstudy.hh +++ b/dune/gdt/test/stationary-eocstudy.hh @@ -147,7 +147,7 @@ public: current_discretization_ = Stuff::Common::make_unique<DiscretizationType>( Discretizer::discretize(test_case_, test_case_.problem(), test_case_.level_of(current_refinement_))); current_solution_vector_on_level_ = Stuff::Common::make_unique<VectorType>(current_discretization_->solve()); - time_to_solution_ = timer.elapsed(); + time_to_solution_ = timer.elapsed(); const ConstDiscreteFunctionType current_refinement_solution( current_discretization_->ansatz_space(), *current_solution_vector_on_level_, "solution on current level"); // prolong to reference grid part diff --git a/dune/gdt/test/stationary-testcase.hh b/dune/gdt/test/stationary-testcase.hh index 819d2f39c6697d07bceb38981e4630e994a58c5e..ed862e5e6c35431e94a93730fd862dcd257f777f 100644 --- a/dune/gdt/test/stationary-testcase.hh +++ b/dune/gdt/test/stationary-testcase.hh @@ -37,7 +37,8 @@ private: "ProblemImp::FunctionType has to be derived from Stuff::LocalizableFunctionInterface!"); typedef Stuff::Functions::Constant<typename FunctionType::EntityType, typename FunctionType::DomainFieldType, FunctionType::dimDomain, typename FunctionType::RangeFieldType, - FunctionType::dimRange> ConstantFunctionType; + FunctionType::dimRange> + ConstantFunctionType; public: template <class... Args> diff --git a/dune/gdt/timestepper/adaptive-rungekutta.hh b/dune/gdt/timestepper/adaptive-rungekutta.hh index 42b3b279092bc0b7c4aa730fb2a15357fa66a947..d402446039656e16df0bb3b59d705857d0237415 100644 --- a/dune/gdt/timestepper/adaptive-rungekutta.hh +++ b/dune/gdt/timestepper/adaptive-rungekutta.hh @@ -208,7 +208,7 @@ public: * \tparam method Adaptive Runge-Kutta method that is used (default is AdaptiveRungeKuttaMethods::dormand_prince) */ template <class OperatorImp, class DiscreteFunctionImp, class TimeFieldImp = double, - TimeStepperMethods method = TimeStepperMethods::dormand_prince> + TimeStepperMethods method = TimeStepperMethods::dormand_prince> class AdaptiveRungeKuttaTimeStepper : public TimeStepperInterface<DiscreteFunctionImp, TimeFieldImp> { typedef TimeStepperInterface<DiscreteFunctionImp, TimeFieldImp> BaseType; @@ -300,7 +300,7 @@ public: size_t first_stage_to_compute = 0; if (last_stage_of_previous_step_) { u_intermediate_stages_[0].vector() = last_stage_of_previous_step_->vector(); - first_stage_to_compute = 1; + first_stage_to_compute = 1; } for (size_t ii = first_stage_to_compute; ii < num_stages_; ++ii) { @@ -339,7 +339,7 @@ public: } // while (mixed_error > tol_) if (!last_stage_of_previous_step_) - last_stage_of_previous_step_ = DSC::make_unique<DiscreteFunctionType>(u_n); + last_stage_of_previous_step_ = DSC::make_unique<DiscreteFunctionType>(u_n); last_stage_of_previous_step_->vector() = u_intermediate_stages_[num_stages_ - 1].vector(); t += actual_dt; diff --git a/dune/gdt/timestepper/explicit-rungekutta.hh b/dune/gdt/timestepper/explicit-rungekutta.hh index 0e1bad017a108f13e16646c25e5864c34657c402..1bc1c28bde6c00295a2e4190bafad553cf4749e4 100644 --- a/dune/gdt/timestepper/explicit-rungekutta.hh +++ b/dune/gdt/timestepper/explicit-rungekutta.hh @@ -165,7 +165,7 @@ struct ButcherArrayProvider<RangeFieldType, TimeFieldType, TimeStepperMethods::e * \tparam DiscreteFunctionImp Type of initial values */ template <class OperatorImp, class DiscreteFunctionImp, class TimeFieldImp = double, - TimeStepperMethods method = TimeStepperMethods::explicit_euler> + TimeStepperMethods method = TimeStepperMethods::explicit_euler> class ExplicitRungeKuttaTimeStepper : public TimeStepperInterface<DiscreteFunctionImp, TimeFieldImp> { typedef TimeStepperInterface<DiscreteFunctionImp, TimeFieldImp> BaseType; @@ -274,7 +274,7 @@ public: TimeFieldType initial_t = t; // start with initial dt TimeFieldType current_dt = initial_dt; - size_t num_refinements = 0; + size_t num_refinements = 0; while (num_refinements < max_refinements) { std::cout << "Trying time step length dt = " << current_dt << "... " << std::flush; bool unlikely_value_occured = false; @@ -295,13 +295,13 @@ public: if (num_steps == max_steps_per_dt) { std::cout << "looks fine" << std::endl; u_n.vector() = initial_u_n.vector(); - t = initial_t; + t = initial_t; return std::make_pair(bool(true), current_dt); } } // if there was a value above threshold start over with smaller dt u_n.vector() = initial_u_n.vector(); - t = initial_t; + t = initial_t; current_dt /= dt_refinement_factor; ++num_refinements; } diff --git a/dune/gdt/timestepper/interface.hh b/dune/gdt/timestepper/interface.hh index 831916b404141aefe0b5d6462ce4fc64e0fce9d0..ebf2a04b7b1574791e1921533cf5b9726f4399e1 100644 --- a/dune/gdt/timestepper/interface.hh +++ b/dune/gdt/timestepper/interface.hh @@ -160,7 +160,7 @@ public: const std::string filename_prefix, SolutionType& sol) { TimeFieldType dt = initial_dt; - TimeFieldType t = current_time(); + TimeFieldType t = current_time(); assert(DSC::FloatCmp::ge(t_end - t, 0.0)); size_t time_step_counter = 0;