diff --git a/benchmarks/advection_in_annulus/advection_in_annulus.cc b/benchmarks/advection_in_annulus/advection_in_annulus.cc index 57eeeaa3149..b0eeeb741e5 100644 --- a/benchmarks/advection_in_annulus/advection_in_annulus.cc +++ b/benchmarks/advection_in_annulus/advection_in_annulus.cc @@ -85,7 +85,7 @@ namespace aspect return k*h_r*sin(k*theta)+rho_0*gravity*(outer_radius-r); } - template + template double Annulus_normal_traction (const Point &pos, const double k) diff --git a/benchmarks/annulus/plugin/annulus.cc b/benchmarks/annulus/plugin/annulus.cc index 9e64841d232..72f77ca337f 100644 --- a/benchmarks/annulus/plugin/annulus.cc +++ b/benchmarks/annulus/plugin/annulus.cc @@ -114,7 +114,7 @@ namespace aspect - template + template Tensor<1,dim> Annulus_velocity (const Point &pos, const double k, @@ -139,7 +139,7 @@ namespace aspect - template + template double Annulus_pressure (const Point &pos, const double k, @@ -156,7 +156,7 @@ namespace aspect - template + template double Annulus_normal_traction (const Point &pos, const double k, @@ -172,7 +172,7 @@ namespace aspect - template + template double Annulus_density (const Point &pos, const double k, @@ -200,7 +200,7 @@ namespace aspect - template + template Tensor<1,dim> Annulus_gravity (const Point &pos, const double k, diff --git a/benchmarks/hollow_sphere/hollow_sphere.cc b/benchmarks/hollow_sphere/hollow_sphere.cc index 8dd449e000a..12ebe62fc77 100644 --- a/benchmarks/hollow_sphere/hollow_sphere.cc +++ b/benchmarks/hollow_sphere/hollow_sphere.cc @@ -132,7 +132,7 @@ namespace aspect return hr*cos(theta) + rho_0 * gravity * (R2 - r); } - template + template double hollow_sphere_normal_traction(const Point &pos, const double mmm) diff --git a/benchmarks/inclusion/compositional_fields/inclusion_compositional_fields.h b/benchmarks/inclusion/compositional_fields/inclusion_compositional_fields.h index ec7b5e8febc..b8d29972826 100644 --- a/benchmarks/inclusion/compositional_fields/inclusion_compositional_fields.h +++ b/benchmarks/inclusion/compositional_fields/inclusion_compositional_fields.h @@ -11,7 +11,7 @@ namespace aspect { using namespace dealii; - template + template class InclusionCompositionalMaterial : public InclusionMaterial { public: diff --git a/benchmarks/nsinker/nsinker.cc b/benchmarks/nsinker/nsinker.cc index beb2d580424..c031bdea433 100644 --- a/benchmarks/nsinker/nsinker.cc +++ b/benchmarks/nsinker/nsinker.cc @@ -196,7 +196,7 @@ namespace aspect }; - template + template NSinkerMaterial::NSinkerMaterial () { delta = 200.0; diff --git a/benchmarks/nsinker_spherical_shell/nsinker.cc b/benchmarks/nsinker_spherical_shell/nsinker.cc index fb8b51a807b..9ae67327596 100644 --- a/benchmarks/nsinker_spherical_shell/nsinker.cc +++ b/benchmarks/nsinker_spherical_shell/nsinker.cc @@ -201,7 +201,7 @@ namespace aspect }; - template + template NSinkerMaterial::NSinkerMaterial () { delta = 2*200.0; diff --git a/benchmarks/operator_splitting/advection_reaction/advection_reaction.cc b/benchmarks/operator_splitting/advection_reaction/advection_reaction.cc index d35cbcb2670..bcc6f70d2e2 100644 --- a/benchmarks/operator_splitting/advection_reaction/advection_reaction.cc +++ b/benchmarks/operator_splitting/advection_reaction/advection_reaction.cc @@ -401,7 +401,7 @@ namespace aspect double max_error_T; }; - template + template ExponentialDecayPostprocessor::ExponentialDecayPostprocessor () { max_error = 0.0; diff --git a/benchmarks/operator_splitting/exponential_decay/exponential_decay.cc b/benchmarks/operator_splitting/exponential_decay/exponential_decay.cc index 06795627478..aa652558752 100644 --- a/benchmarks/operator_splitting/exponential_decay/exponential_decay.cc +++ b/benchmarks/operator_splitting/exponential_decay/exponential_decay.cc @@ -312,7 +312,7 @@ namespace aspect double max_error_T; }; - template + template ExponentialDecayPostprocessor::ExponentialDecayPostprocessor () { max_error = 0.0; diff --git a/benchmarks/rigid_shear/plugin/rigid_shear.cc b/benchmarks/rigid_shear/plugin/rigid_shear.cc index 5293842f3d0..903b0ce97ee 100644 --- a/benchmarks/rigid_shear/plugin/rigid_shear.cc +++ b/benchmarks/rigid_shear/plugin/rigid_shear.cc @@ -68,7 +68,7 @@ namespace aspect return std::exp(t)-1.; } - template + template double density(const Point &p, const double t, @@ -83,7 +83,7 @@ namespace aspect /** * The exact solution for the Rigid Shear benchmark. */ - template + template class FunctionRigidShear : public Function { public: @@ -121,7 +121,7 @@ namespace aspect * A material model for the stationary form of the rigid shear benchmark. All properties * are defined in dependence of position. */ - template + template class RigidShearMaterial : public MaterialModel::Interface, public SimulatorAccess { public: @@ -246,7 +246,7 @@ namespace aspect * The implementation of error evaluators that correspond to the * benchmarks defined in the paper Gassmoeller et al. referenced above. */ - template + template class RigidShearPostprocessor : public Postprocess::Interface, public ::aspect::SimulatorAccess { public: diff --git a/benchmarks/solcx/compositional_fields/solcx_compositional_fields.h b/benchmarks/solcx/compositional_fields/solcx_compositional_fields.h index 0773948ee52..40eafb19602 100644 --- a/benchmarks/solcx/compositional_fields/solcx_compositional_fields.h +++ b/benchmarks/solcx/compositional_fields/solcx_compositional_fields.h @@ -11,7 +11,7 @@ namespace aspect { using namespace dealii; - template + template class SolCxCompositionalMaterial : public SolCxMaterial { public: diff --git a/benchmarks/solcx/solcx.h b/benchmarks/solcx/solcx.h index 1adbdccc17f..23bcd608290 100644 --- a/benchmarks/solcx/solcx.h +++ b/benchmarks/solcx/solcx.h @@ -2894,7 +2894,7 @@ namespace aspect * The exact solution for the SolCx benchmark, given the value of the * jump in viscosity $\eta_B$. */ - template + template class FunctionSolCx : public Function { public: diff --git a/benchmarks/solkz/compositional_fields/solkz_compositional_fields.h b/benchmarks/solkz/compositional_fields/solkz_compositional_fields.h index e4e7537d4d2..8e2e4e7232e 100644 --- a/benchmarks/solkz/compositional_fields/solkz_compositional_fields.h +++ b/benchmarks/solkz/compositional_fields/solkz_compositional_fields.h @@ -12,7 +12,7 @@ namespace aspect { using namespace dealii; - template + template class SolKzCompositionalMaterial : public SolKzMaterial { public: diff --git a/benchmarks/solkz/solkz.h b/benchmarks/solkz/solkz.h index 6725979e6ee..b0df10a9d60 100644 --- a/benchmarks/solkz/solkz.h +++ b/benchmarks/solkz/solkz.h @@ -623,7 +623,7 @@ namespace aspect /** * The exact solution for the SolKz benchmark. */ - template + template class FunctionSolKz : public Function { public: @@ -648,7 +648,7 @@ namespace aspect - template + template class SolKzMaterial : public MaterialModel::Interface { public: @@ -721,7 +721,7 @@ namespace aspect * The implementation of error evaluators that correspond to the * benchmarks defined in the paper Duretz et al. reference above. */ - template + template class SolKzPostprocessor : public Postprocess::Interface, public ::aspect::SimulatorAccess { public: diff --git a/include/aspect/compat.h b/include/aspect/compat.h index 1d575878e1a..14e398770a6 100644 --- a/include/aspect/compat.h +++ b/include/aspect/compat.h @@ -41,7 +41,7 @@ namespace big_mpi #include namespace dealii { - template + template using MGTransferMF = MGTransferMatrixFree; } #endif diff --git a/include/aspect/mesh_deformation/diffusion.h b/include/aspect/mesh_deformation/diffusion.h index f1e84ba65a0..4459211f10c 100644 --- a/include/aspect/mesh_deformation/diffusion.h +++ b/include/aspect/mesh_deformation/diffusion.h @@ -39,7 +39,7 @@ namespace aspect * vertices according to the solution of a dim-1 diffusion * problem. */ - template + template class Diffusion : public Interface, public SimulatorAccess { public: diff --git a/include/aspect/mesh_deformation/fastscape.h b/include/aspect/mesh_deformation/fastscape.h index ef34cf256bb..f087d987365 100644 --- a/include/aspect/mesh_deformation/fastscape.h +++ b/include/aspect/mesh_deformation/fastscape.h @@ -40,7 +40,7 @@ namespace aspect * and the stream power law, which describes river incision. * */ - template + template class FastScape : public Interface, public SimulatorAccess { public: diff --git a/include/aspect/mesh_deformation/free_surface.h b/include/aspect/mesh_deformation/free_surface.h index a3961872e90..7cb6c1fd631 100644 --- a/include/aspect/mesh_deformation/free_surface.h +++ b/include/aspect/mesh_deformation/free_surface.h @@ -40,7 +40,7 @@ namespace aspect * In particular this means if the surface of the domain is * left open to flow, this flow will carry the mesh with it. */ - template + template class FreeSurface : public Interface, public SimulatorAccess { public: diff --git a/include/aspect/mesh_deformation/function.h b/include/aspect/mesh_deformation/function.h index ee53d01d8ae..7f2d29a5258 100644 --- a/include/aspect/mesh_deformation/function.h +++ b/include/aspect/mesh_deformation/function.h @@ -33,7 +33,7 @@ namespace aspect namespace MeshDeformation { - template + template class BoundaryFunction : public Interface, public SimulatorAccess { public: diff --git a/include/aspect/mesh_deformation/interface.h b/include/aspect/mesh_deformation/interface.h index 1c0cf371f11..210b61651d5 100644 --- a/include/aspect/mesh_deformation/interface.h +++ b/include/aspect/mesh_deformation/interface.h @@ -86,7 +86,7 @@ namespace aspect * for all non-constrained vertices will be computed by solving a Laplace * problem with the given constraints. */ - template + template class Interface : public Plugins::InterfaceBase { public: @@ -129,7 +129,7 @@ namespace aspect * of the surface, the internal nodes and computes the * Arbitrary-Lagrangian-Eulerian correction terms. */ - template + template class MeshDeformationHandler: public SimulatorAccess { public: diff --git a/include/aspect/particle/world.h b/include/aspect/particle/world.h index 42b4e1f0a07..3ae4f124818 100644 --- a/include/aspect/particle/world.h +++ b/include/aspect/particle/world.h @@ -46,7 +46,7 @@ namespace aspect { - template + template struct SimulatorSignals; namespace Particle diff --git a/include/aspect/postprocess/particles.h b/include/aspect/postprocess/particles.h index cfdcfb69737..3a05da0d581 100644 --- a/include/aspect/postprocess/particles.h +++ b/include/aspect/postprocess/particles.h @@ -46,7 +46,7 @@ namespace aspect * dimension of zero (the dimension of the particle / point), and a space dimension * of dim (the dimension in which this zero-dimensional particle lives). */ - template + template class ParticleOutput : public dealii::DataOutInterface<0,dim> { public: diff --git a/include/aspect/postprocess/visualization/ISA_rotation_timescale.h b/include/aspect/postprocess/visualization/ISA_rotation_timescale.h index a722ff74558..5c4790c8703 100644 --- a/include/aspect/postprocess/visualization/ISA_rotation_timescale.h +++ b/include/aspect/postprocess/visualization/ISA_rotation_timescale.h @@ -49,7 +49,7 @@ namespace aspect * (once they exist). For more thoughts on that, see the documentation for the * grain lag angle postprocessor. */ - template + template class ISARotationTimescale: public CellDataVectorCreator, public SimulatorAccess { public: diff --git a/include/aspect/postprocess/visualization/grain_lag_angle.h b/include/aspect/postprocess/visualization/grain_lag_angle.h index 61327cc9038..8d5d5eb2204 100644 --- a/include/aspect/postprocess/visualization/grain_lag_angle.h +++ b/include/aspect/postprocess/visualization/grain_lag_angle.h @@ -56,7 +56,7 @@ namespace aspect * timestep behind the other quantities in order to get the gradients, but we're * often interested in GOL in a steady-state flow anyway. */ - template + template class GrainLagAngle: public CellDataVectorCreator, public SimulatorAccess { public: diff --git a/include/aspect/stokes_matrix_free.h b/include/aspect/stokes_matrix_free.h index 98ebce68fbb..e90f857cc4a 100644 --- a/include/aspect/stokes_matrix_free.h +++ b/include/aspect/stokes_matrix_free.h @@ -401,7 +401,7 @@ namespace aspect * Base class for the matrix free GMG solver for the Stokes system. The * actual implementation is found inside StokesMatrixFreeHandlerImplementation below. */ - template + template class StokesMatrixFreeHandler { public: @@ -510,7 +510,7 @@ namespace aspect * degree by using a pointer to the base class and we can pick the desired * velocity degree at runtime. */ - template + template class StokesMatrixFreeHandlerImplementation: public StokesMatrixFreeHandler { public: diff --git a/include/aspect/structured_data.h b/include/aspect/structured_data.h index ed09dda54c8..cc569e1c2a2 100644 --- a/include/aspect/structured_data.h +++ b/include/aspect/structured_data.h @@ -770,7 +770,7 @@ namespace aspect - template + template using AsciiDataLookup DEAL_II_DEPRECATED = StructuredDataLookup; } } diff --git a/include/aspect/volume_of_fluid/field.h b/include/aspect/volume_of_fluid/field.h index c435df1cdff..da88e97ec28 100644 --- a/include/aspect/volume_of_fluid/field.h +++ b/include/aspect/volume_of_fluid/field.h @@ -57,7 +57,7 @@ namespace aspect * Structure to package the relevant data (both state and cached) in a single * location for access. */ - template + template struct VolumeOfFluidField { /** diff --git a/include/aspect/volume_of_fluid/utilities.h b/include/aspect/volume_of_fluid/utilities.h index b5643512eb8..bb04f2a64d4 100644 --- a/include/aspect/volume_of_fluid/utilities.h +++ b/include/aspect/volume_of_fluid/utilities.h @@ -119,7 +119,7 @@ namespace aspect * @param points Quadrature points to use for update * @param weights JxW values to use for quadrature */ - template + template double compute_interface_location_newton(const unsigned int degree, const Tensor<1, dim, double> normal, const double volume_fraction, @@ -140,7 +140,7 @@ namespace aspect * @param points Quadrature points to use for update * @param weights JxW values to use for quadrature */ - template + template double compute_fluid_volume(const unsigned int degree, const Tensor<1, dim, double> normal, const double d, @@ -159,7 +159,7 @@ namespace aspect * @param interface_normal_in_cell The normal vector for the current interface reconstruction in the computing cell. * @param d_at_face_center The correct d value to for the interface description on the face we are computing for. */ - template + template double calculate_volume_flux (const unsigned int compute_direction, const double time_direction_derivative, const Tensor<1, dim, double> interface_normal_in_cell, diff --git a/source/main.cc b/source/main.cc index c29f463abba..77b38b6890c 100644 --- a/source/main.cc +++ b/source/main.cc @@ -542,7 +542,7 @@ void signal_handler(int signal) -template +template void run_simulator(const std::string &raw_input_as_string, const std::string &input_as_string, diff --git a/source/material_model/interface.cc b/source/material_model/interface.cc index 64c084214e4..d6fa560bb10 100644 --- a/source/material_model/interface.cc +++ b/source/material_model/interface.cc @@ -954,7 +954,7 @@ namespace aspect - template + template std::vector NamedAdditionalMaterialOutputs::get_nth_output(const unsigned int idx) const { @@ -1056,7 +1056,7 @@ namespace aspect - template + template ReactionRateOutputs::ReactionRateOutputs (const unsigned int n_points, const unsigned int n_comp) : @@ -1066,7 +1066,7 @@ namespace aspect - template + template std::vector ReactionRateOutputs::get_nth_output(const unsigned int idx) const { @@ -1103,7 +1103,7 @@ namespace aspect - template + template PrescribedFieldOutputs::PrescribedFieldOutputs (const unsigned int n_points, const unsigned int n_comp) : @@ -1113,7 +1113,7 @@ namespace aspect - template + template std::vector PrescribedFieldOutputs::get_nth_output(const unsigned int idx) const { @@ -1129,7 +1129,7 @@ namespace aspect - template + template PrescribedTemperatureOutputs::PrescribedTemperatureOutputs (const unsigned int n_points) : NamedAdditionalMaterialOutputs(std::vector(1,"prescribed_temperature")), @@ -1138,7 +1138,7 @@ namespace aspect - template + template std::vector PrescribedTemperatureOutputs::get_nth_output(const unsigned int idx) const { diff --git a/source/particle/interpolator/quadratic_least_squares.cc b/source/particle/interpolator/quadratic_least_squares.cc index ddf96b6c915..6994103d38c 100644 --- a/source/particle/interpolator/quadratic_least_squares.cc +++ b/source/particle/interpolator/quadratic_least_squares.cc @@ -64,7 +64,7 @@ namespace aspect } - template + template std::pair QuadraticLeastSquares::get_interpolation_bounds(const Vector &coefficients) const { double interpolation_min = std::numeric_limits::max(); diff --git a/source/particle/property/cpo_bingham_average.cc b/source/particle/property/cpo_bingham_average.cc index 6d5bb050652..df6540f6407 100644 --- a/source/particle/property/cpo_bingham_average.cc +++ b/source/particle/property/cpo_bingham_average.cc @@ -117,7 +117,7 @@ namespace aspect - template + template std::array,3> CpoBinghamAverage::compute_bingham_average(std::vector> matrices) const { diff --git a/source/particle/property/crystal_preferred_orientation.cc b/source/particle/property/crystal_preferred_orientation.cc index e25679e8ab3..6494f4d85c7 100644 --- a/source/particle/property/crystal_preferred_orientation.cc +++ b/source/particle/property/crystal_preferred_orientation.cc @@ -806,7 +806,7 @@ namespace aspect } - template + template DeformationType CrystalPreferredOrientation::determine_deformation_type(const DeformationTypeSelector deformation_type_selector, const Point &position, @@ -864,7 +864,7 @@ namespace aspect } - template + template DeformationType CrystalPreferredOrientation::determine_deformation_type_karato_2008(const double stress, const double water_content) const { @@ -902,7 +902,7 @@ namespace aspect } - template + template std::array CrystalPreferredOrientation::reference_resolved_shear_stress_from_deformation_type(DeformationType deformation_type, double max_value) const @@ -974,7 +974,7 @@ namespace aspect return ref_resolved_shear_stress; } - template + template unsigned int CrystalPreferredOrientation::get_number_of_grains() const { @@ -983,7 +983,7 @@ namespace aspect - template + template unsigned int CrystalPreferredOrientation::get_number_of_minerals() const { diff --git a/source/postprocess/particles.cc b/source/postprocess/particles.cc index 9ed34659b77..5d7a7e8a00e 100644 --- a/source/postprocess/particles.cc +++ b/source/postprocess/particles.cc @@ -35,7 +35,7 @@ namespace aspect { namespace internal { - template + template void ParticleOutput::build_patches(const dealii::Particles::ParticleHandler &particle_handler, const aspect::Particle::Property::ParticlePropertyInformation &property_information, diff --git a/source/postprocess/visualization/ISA_rotation_timescale.cc b/source/postprocess/visualization/ISA_rotation_timescale.cc index daa65147d28..bb7a48614c7 100644 --- a/source/postprocess/visualization/ISA_rotation_timescale.cc +++ b/source/postprocess/visualization/ISA_rotation_timescale.cc @@ -42,7 +42,7 @@ namespace aspect - template + template std::pair>> ISARotationTimescale::execute() const { diff --git a/source/postprocess/visualization/grain_lag_angle.cc b/source/postprocess/visualization/grain_lag_angle.cc index cd4be9b5768..e1983a603a5 100644 --- a/source/postprocess/visualization/grain_lag_angle.cc +++ b/source/postprocess/visualization/grain_lag_angle.cc @@ -42,7 +42,7 @@ namespace aspect - template + template std::pair>> GrainLagAngle::execute() const { diff --git a/source/simulator/assemblers/interface.cc b/source/simulator/assemblers/interface.cc index 887d47d17d9..492035506e5 100644 --- a/source/simulator/assemblers/interface.cc +++ b/source/simulator/assemblers/interface.cc @@ -357,7 +357,7 @@ namespace aspect {} - template + template void AdvectionSystem:: reinit (const typename DoFHandler::active_cell_iterator &cell_ref) diff --git a/source/volume_of_fluid/handler.cc b/source/volume_of_fluid/handler.cc index 242a81f0056..c1449a30238 100644 --- a/source/volume_of_fluid/handler.cc +++ b/source/volume_of_fluid/handler.cc @@ -154,7 +154,7 @@ namespace aspect - template + template VolumeOfFluidSystem::VolumeOfFluidSystem(const VolumeOfFluidSystem &data) : local_matrix (data.local_matrix), diff --git a/source/volume_of_fluid/utilities.cc b/source/volume_of_fluid/utilities.cc index 3dffc520cbc..fe9cacefc70 100644 --- a/source/volume_of_fluid/utilities.cc +++ b/source/volume_of_fluid/utilities.cc @@ -555,7 +555,7 @@ namespace aspect - template + template double compute_interface_location_newton(const unsigned int degree, const Tensor<1, dim> normal, const double volume_fraction, @@ -623,7 +623,7 @@ namespace aspect return d_guess; } - template + template double compute_fluid_volume(const unsigned int degree, const Tensor<1, dim> normal, const double d, @@ -641,7 +641,7 @@ namespace aspect return fluid_volume; } - template + template double calculate_volume_flux(const unsigned int dir, const double time_direction_derivative, const Tensor<1, dim> normal, diff --git a/tests/box_initial_mesh_deformation.cc b/tests/box_initial_mesh_deformation.cc index 97a2e26455f..56b3edfdad0 100644 --- a/tests/box_initial_mesh_deformation.cc +++ b/tests/box_initial_mesh_deformation.cc @@ -29,7 +29,7 @@ namespace aspect namespace MeshDeformation { - template + template class PrescribedDeformation : public Interface, public SimulatorAccess { public: diff --git a/tests/drucker_prager_derivatives_2d.cc b/tests/drucker_prager_derivatives_2d.cc index 320f253b5bd..d6d713fb9fb 100644 --- a/tests/drucker_prager_derivatives_2d.cc +++ b/tests/drucker_prager_derivatives_2d.cc @@ -33,7 +33,7 @@ #include -template +template void f(const aspect::SimulatorAccess &simulator_access, aspect::Assemblers::Manager &) { diff --git a/tests/drucker_prager_derivatives_3d.cc b/tests/drucker_prager_derivatives_3d.cc index 4318a4ab5b7..33aabf18543 100644 --- a/tests/drucker_prager_derivatives_3d.cc +++ b/tests/drucker_prager_derivatives_3d.cc @@ -33,7 +33,7 @@ #include -template +template void f(const aspect::SimulatorAccess &simulator_access, aspect::Assemblers::Manager &) { diff --git a/tests/rheology_scaled_profile.cc b/tests/rheology_scaled_profile.cc index b6014465ad7..3795ec41aad 100644 --- a/tests/rheology_scaled_profile.cc +++ b/tests/rheology_scaled_profile.cc @@ -98,7 +98,7 @@ namespace aspect * an unscaled (constant) viscosity profile, which is then scaled by the quotient between reference * profile and unscaled viscosity. */ - template + template class ScaledViscosityProfileMaterial : public MaterialModel::Interface, public aspect::SimulatorAccess { public: diff --git a/tests/simple_nonlinear.cc b/tests/simple_nonlinear.cc index 4ecb2828ab4..db839536247 100644 --- a/tests/simple_nonlinear.cc +++ b/tests/simple_nonlinear.cc @@ -30,7 +30,7 @@ #include "../benchmarks/newton_solver_benchmark_set/nonlinear_channel_flow/simple_nonlinear.cc" -template +template int f(double parameter) {