Base<dim,VectorType>::Base ()
:
Subscriptor(),
- data(NULL),
have_interface_matrices(false)
{
+ // boost-1.62.0 doesn't allow initializing a shared_ptr
+ // with NULL. Make sure the default constructor does that.
+ Assert(data.get() == NULL, ExcInternalError());
}
dof_u.distribute_dofs(fe_u);
dof_p.distribute_dofs(fe_p);
- std::shared_ptr<MatrixFree<dim, double> > mf_data;
+ std_cxx11::shared_ptr<MatrixFree<dim, double> > mf_data;
dof.distribute_dofs(fe);
ConstraintMatrix constraints, constraints_u, constraints_p;
const FEValuesExtractors::Vector velocities(0);
const FEValuesExtractors::Scalar pressure(dim);
- std::vector<SymmetricTensor<2, dim>> phi_grads_u(dofs_per_cell);
+ std::vector<SymmetricTensor<2, dim> > phi_grads_u(dofs_per_cell);
std::vector<double> div_phi_u(dofs_per_cell);
std::vector<double> phi_p(dofs_per_cell);
mf_system_rhs.block(1)(j) = val;
}
- mf_data = std::shared_ptr<MatrixFree<dim, double> >(new MatrixFree<dim, double>());
+ mf_data = std_cxx11::shared_ptr<MatrixFree<dim, double> >(new MatrixFree<dim, double>());
// setup matrix-free structure
{
std::vector<const DoFHandler<dim>*> dofs;