void add_parameter(const std::string &entry,
ParameterType ¶meter,
const std::string &documentation = std::string(),
- ParameterHandler &prm = ParameterAcceptor::prm,
+ ParameterHandler &prm_ = prm,
const Patterns::PatternBase &pattern =
*Patterns::Tools::Convert<ParameterType>::to_pattern());
class ActiveCellIterator
{
public:
+#ifndef _MSC_VER
typedef typename MeshType::active_cell_iterator type;
+#else
+ typedef TriaActiveIterator<dealii::CellAccessor<dim, spacedim> > type;
+#endif
};
+#ifdef _MSC_VER
template <int dim, int spacedim>
class ActiveCellIterator<dim, spacedim, dealii::DoFHandler<dim, spacedim> >
{
public:
-#ifndef _MSC_VER
- typedef typename dealii::DoFHandler<dim, spacedim>::active_cell_iterator type;
-#else
- typedef TriaActiveIterator < dealii::DoFCellAccessor < dealii::DoFHandler<dim, spacedim>, false > > type;
-#endif
+ typedef TriaActiveIterator < dealii::DoFCellAccessor < dealii::DoFHandler<dim, spacedim >, false> > type;
};
template <int dim, int spacedim>
class ActiveCellIterator<dim, spacedim, dealii::hp::DoFHandler<dim, spacedim> >
{
public:
-#ifndef _MSC_VER
- typedef typename dealii::hp::DoFHandler<dim, spacedim>::active_cell_iterator type;
-#else
- typedef TriaActiveIterator < dealii::DoFCellAccessor < dealii::hp::DoFHandler<dim, spacedim>, false > > type;
-#endif
+ typedef TriaActiveIterator < dealii::DoFCellAccessor < dealii::hp::DoFHandler<dim, spacedim >, false> > type;
};
+#endif
}
/**
// cases.
const double step_size = object->diameter()/64.0;
- std::array<Point<spacedim>, GeometryInfo<structdim>::vertices_per_cell> vertices;
- for (unsigned int vertex_n = 0; vertex_n < GeometryInfo<structdim>::vertices_per_cell;
+ constexpr unsigned int n_vertices_per_cell = GeometryInfo<structdim>::vertices_per_cell;
+
+ std::array<Point<spacedim>, n_vertices_per_cell> vertices;
+ for (unsigned int vertex_n = 0; vertex_n < n_vertices_per_cell;
++vertex_n)
vertices[vertex_n] = object->vertex(vertex_n);
auto get_point_from_weights =
- [&](const Tensor<1, GeometryInfo<structdim>::vertices_per_cell> &weights)
+ [&](const Tensor<1, n_vertices_per_cell> &weights)
-> Point<spacedim>
{
return object->get_manifold().get_new_point
(make_array_view(vertices.begin(), vertices.end()),
make_array_view(&weights[0],
- &weights[GeometryInfo<structdim>::vertices_per_cell - 1] + 1));
+ &weights[n_vertices_per_cell - 1] + 1));
};
// pick the initial weights as (normalized) inverse distances from
// the trial point:
- Tensor<1, GeometryInfo<structdim>::vertices_per_cell> guess_weights;
+ Tensor<1, n_vertices_per_cell> guess_weights;
double guess_weights_sum = 0.0;
- for (unsigned int vertex_n = 0; vertex_n < GeometryInfo<structdim>::vertices_per_cell;
+ for (unsigned int vertex_n = 0; vertex_n < n_vertices_per_cell;
++vertex_n)
{
const double distance = vertices[vertex_n].distance(trial_point);
//
for (unsigned int outer_n = 0; outer_n < 40; ++outer_n)
{
- const unsigned int dependent_direction = GeometryInfo<structdim>::vertices_per_cell - 1;
- Tensor<1, GeometryInfo<structdim>::vertices_per_cell> current_gradient;
+ const unsigned int dependent_direction = n_vertices_per_cell - 1;
+ Tensor<1, n_vertices_per_cell> current_gradient;
for (unsigned int row_n = 0;
- row_n < GeometryInfo<structdim>::vertices_per_cell;
+ row_n < n_vertices_per_cell;
++row_n)
{
if (row_n != dependent_direction)
// between zero and one. If the update takes us outside of this
// region then rescale the update to stay within the region and
// try again
- Tensor<1, GeometryInfo<structdim>::vertices_per_cell> tentative_weights =
+ Tensor<1, n_vertices_per_cell> tentative_weights =
guess_weights + gradient_weight*current_gradient;
double new_gradient_weight = gradient_weight;
if (internal::weights_are_ok<structdim>(tentative_weights))
break;
- for (unsigned int i = 0; i < GeometryInfo<structdim>::vertices_per_cell; ++i)
+ for (unsigned int i = 0; i < n_vertices_per_cell; ++i)
{
if (tentative_weights[i] < 0.0)
{
* The DoFHandler is actually not needed.
*/
template <int dim>
+#ifndef _MSC_VER
DEAL_II_DEPRECATED
+#endif
Multigrid(const DoFHandler<dim> &mg_dof_handler,
const MGMatrixBase<VectorType> &matrix,
const MGCoarseGridBase<VectorType> &coarse,
const Quadrature<dim-1> &q_boundary,
const bool project_to_boundary_first)
{
+#ifdef _MSC_VER
+ Assert(false,
+ ExcMessage("Please specify the mapping explicitly "
+ "when building with MSVC!"));
+#else
project(StaticMappingQ1<dim,spacedim>::mapping, dof, constraints, quadrature, function, vec,
enforce_zero_boundary, q_boundary, project_to_boundary_first);
+#endif
}
Assert (false, ExcNotImplemented());
}
+ template <int dim, int spacedim>
+ void
+ Triangulation<dim, spacedim>::fill_level_ghost_owners()
+ {
+ Assert(false, ExcNotImplemented());
+ }
+
#endif
template <int dim, int spacedim>
// variables from FEValuesBase, but they aren't initialized yet
// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = internal::make_shape_function_to_row_table (fe);
+ = dealii::internal::make_shape_function_to_row_table (fe);
for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
{
// variables from FEValuesBase, but they aren't initialized yet
// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = internal::make_shape_function_to_row_table (fe);
+ = dealii::internal::make_shape_function_to_row_table (fe);
for (unsigned int d=0; d<spacedim; ++d)
{
// variables from FEValuesBase, but they aren't initialized yet
// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = internal::make_shape_function_to_row_table (fe);
+ = dealii::internal::make_shape_function_to_row_table (fe);
for (unsigned int d = 0; d < dealii::SymmetricTensor<2,dim>::n_independent_components; ++d)
{
// variables from FEValuesBase, but they aren't initialized yet
// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = internal::make_shape_function_to_row_table (fe);
+ = dealii::internal::make_shape_function_to_row_table (fe);
for (unsigned int d = 0; d < dim*dim; ++d)
{
// the rows in the tables storing the data by shape function and
// nonzero component
this->shape_function_to_row_table
- = internal::make_shape_function_to_row_table (fe);
+ = dealii::internal::make_shape_function_to_row_table (fe);
// count the total number of non-zero components accumulated
// over all shape functions
const Point<spacedim> &p2,
const double w) const
{
- const std::array<Point<spacedim>, 2> points({{p1, p2}});
- const std::array<double, 2> weights({{1.-w, w}});
+ const std::array<Point<spacedim>, 2> points {{p1, p2}};
+ const std::array<double, 2> weights {{1.-w, w}};
return get_new_point(make_array_view(points.begin(), points.end()),
make_array_view(weights.begin(), weights.end()));
}