// follows. Note that this sets the manifold object used for part "0" of the
// domain back to a default object, over which the triangulation has full
// control.
- triangulation.set_manifold (0);
+ triangulation.reset_manifold(0);
// An alternative to doing so, and one that is frequently more convenient,
// would have been to declare the manifold object before the triangulation
// object. In that case, the triangulation would have let lose of the
// object is destroyed first in this function since it was declared after
// the triangulation).
print_mesh_info (triangulation, "grid-3.eps");
- triangulation.set_manifold (1);
+ triangulation.reset_manifold(1);
}
// There is one snag to doing things as shown above: If one moves the nodes on
solve();
output_results();
- tria.set_manifold(1);
+ tria.reset_manifold(1);
for (unsigned int i=0; i<dof_handler_q.n_dofs(); ++i)
global_error +=
dh_test.clear();
- tria.set_manifold(0);
+ tria.reset_manifold(0);
return 0;
}
data_out_euler.write_vtk(deallog.get_file_stream());
- triangulation.set_manifold(0);
+ triangulation.reset_manifold(0);
}
int main ()
GridGenerator::extract_boundary_mesh (volume_mesh, triangulation,
boundary_ids);
- triangulation.set_manifold (0);
+ triangulation.reset_manifold(0);
GridTools::transform (&warp<3>, triangulation);
deallog << "Surface mesh has " << triangulation.n_active_cells()
deallog << "Writing refined from constructor" << std::endl;
go.write_ucd(tr, out);
- tr.set_manifold(1);
+ tr.reset_manifold(1);
tr.clear();
GridIn<dim> gi;
grid_file.close();
}
- tr.set_manifold(1);
+ tr.reset_manifold(1);
tr.clear();
}
tria.execute_coarsening_and_refinement();
};
- tria.set_manifold (1);
+ tria.reset_manifold(1);
break;
}
}
GridOut gridout;
gridout.write_msh(tria, deallog.get_file_stream());
- tria.set_manifold(1);
+ tria.reset_manifold(1);
}
int main ()
points[95]=p;
fe_function.value_list (points, m); // <<<< this fails at point[95] but only if the other points are filled in?!
- triangulation.set_manifold (0);
+ triangulation.reset_manifold(0);
deallog << "OK" << std::endl;
}
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
deallog << "OK" << std::endl;
- tr.set_manifold(99);
+ tr.reset_manifold(99);
}
if (myid==0)
x_dub.print(deallog.get_file_stream(), 8, true, false);
- tr.set_manifold (0);
- tr.set_manifold (1);
+ tr.reset_manifold(0);
+ tr.reset_manifold(1);
}
std::ofstream output (filename.c_str());
data_out.write_deal_II_intermediate (output);
- tr.set_manifold (0);
- tr.set_manifold (1);
+ tr.reset_manifold(0);
+ tr.reset_manifold(1);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
deallog << "OK" << std::endl;
}
std::ofstream output (filename.c_str());
data_out.write_vtu (output);
- tr.set_manifold (0);
- tr.set_manifold (1);
+ tr.reset_manifold(0);
+ tr.reset_manifold(1);
if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
deallog << "OK" << std::endl;