From: kronbichler Date: Fri, 4 Dec 2009 14:48:02 +0000 (+0000) Subject: Set svn properties on hp/fe_nothing_03. Do not output the results of deal.II/mesh_wor... X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=a257c45f6d61a2dbe09dbaa24c8048db3553f746;p=dealii-svn.git Set svn properties on hp/fe_nothing_03. Do not output the results of deal.II/mesh_worker_01. git-svn-id: https://svn.dealii.org/trunk@20201 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/tests/deal.II/create_mass_matrix_01.cc b/tests/deal.II/create_mass_matrix_01.cc index f055476a6d..a86c374b0e 100644 --- a/tests/deal.II/create_mass_matrix_01.cc +++ b/tests/deal.II/create_mass_matrix_01.cc @@ -1,6 +1,6 @@ //---------------------------- create_mass_matrix_01.cc --------------------------- // $Id$ -// Version: $Name$ +// Version: $Name$ // // Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008 by the deal.II authors // @@ -52,7 +52,7 @@ template void check () { - Triangulation tr; + Triangulation tr; if (dim==2) GridGenerator::hyper_ball(tr, Point(), 1); else @@ -86,14 +86,14 @@ check () constraints.close (); constraints.condense (sparsity); sparsity.compress (); - + SparseMatrix matrix; matrix.reinit (sparsity); Functions::ExpFunction rhs_function; - + Vector rhs (dof.n_dofs()); - + MatrixTools:: create_mass_matrix (mapping, dof, quadrature, matrix, @@ -122,7 +122,7 @@ int main () { std::ofstream logfile ("create_mass_matrix_01/output"); deallog << std::setprecision (2); - deallog << std::fixed; + deallog << std::fixed; deallog.attach(logfile); deallog.depth_console (0); diff --git a/tests/deal.II/mesh_worker_01.cc b/tests/deal.II/mesh_worker_01.cc index a8101c9423..53a584bdf1 100644 --- a/tests/deal.II/mesh_worker_01.cc +++ b/tests/deal.II/mesh_worker_01.cc @@ -1,6 +1,6 @@ //---------------------------------------------------------------------- // $Id$ -// Version: $Name$ +// Version: $Name$ // // Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009 by the deal.II authors // @@ -35,14 +35,14 @@ using namespace dealii; // Define a class that fills all available entries in the info objects -// with recognizable numbers. +// with recognizable numbers. template class Local : public Subscriptor { public: typedef typename MeshWorker::IntegrationWorker::CellInfo CellInfo; typedef typename MeshWorker::IntegrationWorker::FaceInfo FaceInfo; - + void cell(CellInfo& info) const; void bdry(FaceInfo& info) const; void face(FaceInfo& info1, FaceInfo& info2) const; @@ -73,7 +73,7 @@ Local::cell(CellInfo& info) const for (unsigned int i=0;i::cell(CellInfo& info) const const double x = cell + 0.1 * b + 0.001 * i; info.R[k].block(b)(i) = x; } - + for (unsigned int k=0;k& dof_handler, WORKER& worker) { const FiniteElement& fe = dof_handler.get_fe(); MappingQ1 mapping; - + MeshWorker::IntegrationInfoBox info_box(dof_handler); info_box.initialize(worker, fe, mapping); - + MeshWorker::integration_loop(dof_handler.begin_active(), dof_handler.end(), info_box, worker); } @@ -151,17 +151,17 @@ test_simple(MGDoFHandler& mgdofs) pattern.compress(); matrix.reinit (pattern); v.reinit (dofs.n_dofs()); - + Local local; local.cells = true; local.faces = false; - + MeshWorker::AssemblingIntegrator, Vector >, Local > integrator(local); integrator.initialize_gauss_quadrature(1, 1, 1); integrator.initialize(matrix, v); integrator.boundary_fluxes = local.faces; - integrator.interior_fluxes = local.faces; + integrator.interior_fluxes = local.faces; assemble(dofs, integrator); for (unsigned int i=0;i& fe) for (unsigned int l=0;l::cell_iterator cell = tr.begin(); cell != tr.end(); ++cell, ++cn) @@ -201,7 +201,7 @@ test(const FiniteElement& fe) for (unsigned int l=0;l > > fe2; fe2.push_back(boost::shared_ptr >(new FE_DGP<2>(1))); fe2.push_back(boost::shared_ptr >(new FE_Q<2>(1))); - + for (unsigned int i=0;i