double
volume(const Triangulation<dim, spacedim> &tria,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* Return an approximation of the diameter of the smallest active cell of a
minimal_cell_diameter(
const Triangulation<dim, spacedim> &triangulation,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* Return an approximation of the diameter of the largest active cell of a
maximal_cell_diameter(
const Triangulation<dim, spacedim> &triangulation,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* Given a list of vertices (typically obtained using
extract_used_vertices(
const Triangulation<dim, spacedim> &container,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* Find and return the index of the closest vertex to a given point in the
const typename Triangulation<dim, spacedim>::active_cell_iterator &cell,
const Point<spacedim> & position,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* Compute a globally unique index for each vertex and hanging node
*/
Cache(const Triangulation<dim, spacedim> &tria,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* Destructor.
& function_map,
AffineConstraints<double> & constraints,
const Mapping<dim, spacedim> &mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* This function does the same as the
const std::set<types::boundary_id> &boundary_ids,
AffineConstraints<double> & constraints,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* Compute the constraints that correspond to boundary conditions of the
& function_map,
AffineConstraints<double> & constraints,
const Mapping<dim, spacedim> &mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* Same as above for homogeneous tangential-flux constraints.
const std::set<types::boundary_id> &boundary_ids,
AffineConstraints<double> & constraints,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
//@}
} // namespace VectorTools
const std::vector<Point<dim>> & particle_reference_locations,
ParticleHandler<dim, spacedim> & particle_handler,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* A function that generates one particle at a random location in cell @p cell and with
const types::particle_index id,
std::mt19937 & random_number_generator,
const Mapping<dim, spacedim> &mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>());
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()));
/**
* A function that generates particles randomly in the domain with a
const types::particle_index n_particles_to_create,
ParticleHandler<dim, spacedim> & particle_handler,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>(),
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()),
const unsigned int random_number_seed = 5432);
& global_bounding_boxes,
ParticleHandler<dim, spacedim> &particle_handler,
const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>(),
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()),
const ComponentMask & components = ComponentMask(),
const std::vector<std::vector<double>> &properties = {});
*/
template <int dim, int spacedim = dim>
void
- quadrature_points(const Triangulation<dim, spacedim> &triangulation,
- const Quadrature<dim> & quadrature,
- const std::vector<std::vector<BoundingBox<spacedim>>>
- & global_bounding_boxes,
- ParticleHandler<dim, spacedim> &particle_handler,
- const Mapping<dim, spacedim> & mapping =
- ReferenceCell::Type::get_hypercube<dim>()
- .template get_default_linear_mapping<dim, spacedim>(),
- const std::vector<std::vector<double>> &properties = {});
+ quadrature_points(
+ const Triangulation<dim, spacedim> &triangulation,
+ const Quadrature<dim> & quadrature,
+ const std::vector<std::vector<BoundingBox<spacedim>>>
+ & global_bounding_boxes,
+ ParticleHandler<dim, spacedim> &particle_handler,
+ const Mapping<dim, spacedim> & mapping =
+ (ReferenceCell::Type::get_hypercube<dim>()
+ .template get_default_linear_mapping<dim, spacedim>()),
+ const std::vector<std::vector<double>> &properties = {});
} // namespace Generators
} // namespace Particles