From: Guido Kanschat Date: Tue, 15 Jun 2010 16:05:03 +0000 (+0000) Subject: remove FaceInfo X-Git-Tag: v8.0.0~6051 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=9c26158215a0114b1844563497f27a6849a747ee;p=dealii.git remove FaceInfo git-svn-id: https://svn.dealii.org/trunk@21211 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/tests/deal.II/mesh_worker_01.cc b/tests/deal.II/mesh_worker_01.cc index da59ce01d6..b4cbe552c5 100644 --- a/tests/deal.II/mesh_worker_01.cc +++ b/tests/deal.II/mesh_worker_01.cc @@ -42,12 +42,11 @@ class Local : public Subscriptor { public: typedef typename MeshWorker::IntegrationWorker::CellInfo CellInfo; - typedef typename MeshWorker::IntegrationWorker::FaceInfo FaceInfo; - + void cell(MeshWorker::DoFInfo& dinfo, CellInfo& info) const; - void bdry(MeshWorker::DoFInfo& dinfo, FaceInfo& info) const; + void bdry(MeshWorker::DoFInfo& dinfo, CellInfo& info) const; void face(MeshWorker::DoFInfo& dinfo1, MeshWorker::DoFInfo& dinfo2, - FaceInfo& info1, FaceInfo& info2) const; + CellInfo& info1, CellInfo& info2) const; bool cells; bool faces; @@ -103,7 +102,7 @@ Local::cell(MeshWorker::DoFInfo& info, CellInfo&) const template void -Local::bdry(MeshWorker::DoFInfo& info, FaceInfo&) const +Local::bdry(MeshWorker::DoFInfo& info, CellInfo&) const { const unsigned int cell = info.cell->user_index(); deallog << "Bdry " << std::setw(2) << cell; @@ -114,7 +113,7 @@ Local::bdry(MeshWorker::DoFInfo& info, FaceInfo&) const template void Local::face(MeshWorker::DoFInfo& info1, MeshWorker::DoFInfo& info2, - FaceInfo&, FaceInfo&) const + CellInfo&, CellInfo&) const { const unsigned int cell1 = info1.cell->user_index(); const unsigned int cell2 = info2.cell->user_index(); @@ -147,9 +146,7 @@ test_simple(MGDoFHandler& mgdofs) MeshWorker::IntegrationWorker integrator; integrator.initialize_gauss_quadrature(1, 1, 1); - integrator.boundary_fluxes = local.faces; - integrator.interior_fluxes = local.faces; - + MeshWorker::Assembler::SystemSimple, Vector > assembler; assembler.initialize(matrix, v); diff --git a/tests/deal.II/mesh_worker_02.cc b/tests/deal.II/mesh_worker_02.cc index bc76870c39..753e946ffb 100644 --- a/tests/deal.II/mesh_worker_02.cc +++ b/tests/deal.II/mesh_worker_02.cc @@ -43,11 +43,11 @@ class MatrixIntegrator : public Subscriptor static void cell(MeshWorker::DoFInfo& dinfo, typename MeshWorker::IntegrationWorker::CellInfo& info); static void bdry(MeshWorker::DoFInfo& dinfo, - typename MeshWorker::IntegrationWorker::FaceInfo& info); + typename MeshWorker::IntegrationWorker::CellInfo& info); static void face(MeshWorker::DoFInfo& dinfo1, MeshWorker::DoFInfo& dinfo2, - typename MeshWorker::IntegrationWorker::FaceInfo& info1, - typename MeshWorker::IntegrationWorker::FaceInfo& info2); + typename MeshWorker::IntegrationWorker::CellInfo& info1, + typename MeshWorker::IntegrationWorker::CellInfo& info2); }; @@ -68,7 +68,7 @@ void MatrixIntegrator::cell(MeshWorker::DoFInfo& dinfo, template void MatrixIntegrator::bdry(MeshWorker::DoFInfo& dinfo, - typename MeshWorker::IntegrationWorker::FaceInfo& info) + typename MeshWorker::IntegrationWorker::CellInfo& info) { const FEValuesBase& fe = info.fe_values(); FullMatrix& local_matrix = dinfo.matrix(0).matrix; @@ -89,8 +89,8 @@ void MatrixIntegrator::bdry(MeshWorker::DoFInfo& dinfo, template void MatrixIntegrator::face(MeshWorker::DoFInfo& dinfo1, MeshWorker::DoFInfo& dinfo2, - typename MeshWorker::IntegrationWorker::FaceInfo& info1, - typename MeshWorker::IntegrationWorker::FaceInfo& info2) + typename MeshWorker::IntegrationWorker::CellInfo& info1, + typename MeshWorker::IntegrationWorker::CellInfo& info2) { const FEValuesBase& fe1 = info1.fe_values(); const FEValuesBase& fe2 = info2.fe_values();