// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
+// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2011, 2013 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include "../tests.h"
#include "empty_info.h"
-#include <deal.II/numerics/mesh_worker.h>
-#include <deal.II/numerics/mesh_worker_assembler.h>
-#include <deal.II/numerics/mesh_worker_loop.h>
+#include <deal.II/meshworker/assembler.h>
+#include <deal.II/meshworker/loop.h>
#include <deal.II/base/std_cxx1x/function.h>
#include <deal.II/base/logstream.h>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
+// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2011, 2013 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
// Provide scratch data objects with no contents for the MeshWorker::loop()
-#include <deal.II/numerics/mesh_worker_info.h>
+#include <deal.II/meshworker/dof_info.h>
class EmptyInfo
{
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
+// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2011, 2013 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include "../tests.h"
#include "empty_info.h"
-#include <deal.II/numerics/mesh_worker.h>
-#include <deal.II/numerics/mesh_worker_assembler.h>
-#include <deal.II/numerics/mesh_worker_loop.h>
+#include <deal.II/meshworker/assembler.h>
+#include <deal.II/meshworker/loop.h>
#include <deal.II/base/std_cxx1x/function.h>
#include <deal.II/base/logstream.h>
//--------------------------------------------------------------------
// $Id$
//
-// Copyright (C) 2012 by the deal.II authors
+// Copyright (C) 2012, 2013 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
int main()
{
- const std::string logname = JobIdentifier::base_name(__FILE__) + std::string("/output");
- std::ofstream logfile(logname.c_str());
- deallog.attach(logfile);
- deallog.depth_console(0);
+ initlog(__FILE__);
deallog.threshold_double(1.e-10);
Triangulation<2> tr2;
//----------------------------------------------------------------------
// $Id$
//
-// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2012 by the deal.II authors
+// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2012, 2013 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
// right place.
#include "../tests.h"
-#include <deal.II/numerics/mesh_worker.h>
-#include <deal.II/numerics/mesh_worker_assembler.h>
-#include <deal.II/numerics/mesh_worker_loop.h>
+#include <deal.II/meshworker/assembler.h>
+#include <deal.II/meshworker/loop.h>
#include <deal.II/base/std_cxx1x/function.h>
#include <deal.II/base/logstream.h>
assembler;
assembler.initialize(matrix, v);
- MeshWorker::integration_loop<dim, dim>
+ MeshWorker::loop<dim, dim, MeshWorker::DoFInfo<dim>, MeshWorker::IntegrationInfoBox<dim> >
(dofs.begin_active(), dofs.end(),
dof_info, info_box,
std_cxx1x::bind (&Local<dim>::cell, local, std_cxx1x::_1, std_cxx1x::_2),
//----------------------------------------------------------------------
// $Id$
//
-// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2012 by the deal.II authors
+// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2012, 2013 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
// Test consistency of assemblers MatrixSimple and MGMatrixSimple
#include "../tests.h"
-#include <deal.II/numerics/mesh_worker.h>
-#include <deal.II/numerics/mesh_worker_assembler.h>
-#include <deal.II/numerics/mesh_worker_loop.h>
+#include <deal.II/meshworker/assembler.h>
+#include <deal.II/meshworker/loop.h>
#include <deal.II/base/logstream.h>
#include <deal.II/lac/compressed_sparsity_pattern.h>
MeshWorker::Assembler::MatrixSimple<SparseMatrix<double> > assembler;
assembler.initialize(matrix);
- MeshWorker::integration_loop<dim, dim>
+ MeshWorker::loop<dim, dim, MeshWorker::DoFInfo<dim>, MeshWorker::IntegrationInfoBox<dim> >
(dof_handler.begin_active(),
dof_handler.end(),
dof_info,
mg_matrix_dg_up.resize(0, n_levels-1);
mg_matrix_dg_down.resize(0, n_levels-1);
- for (unsigned int level=mg_sparsity.get_minlevel();
- level<=mg_sparsity.get_maxlevel();++level)
+ for (unsigned int level=mg_sparsity.min_level();
+ level<=mg_sparsity.max_level();++level)
{
CompressedSparsityPattern c_sparsity(mgdofs.n_dofs(level));
CompressedSparsityPattern ci_sparsity;
//----------------------------------------------------------------------
// $Id$
//
-// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2012 by the deal.II authors
+// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008, 2009, 2010, 2012, 2013 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
// Test consistency of assemblers MatrixSimple with and without local blocks
#include "../tests.h"
-#include <deal.II/numerics/mesh_worker.h>
-#include <deal.II/numerics/mesh_worker_assembler.h>
-#include <deal.II/numerics/mesh_worker_loop.h>
+#include <deal.II/meshworker/assembler.h>
+#include <deal.II/meshworker/loop.h>
#include <deal.II/base/logstream.h>
#include <deal.II/lac/compressed_sparsity_pattern.h>
MeshWorker::Assembler::MatrixSimple<SparseMatrix<double> > assembler;
assembler.initialize(matrix);
- MeshWorker::integration_loop<dim, dim>
+ MeshWorker::loop<dim, dim, MeshWorker::DoFInfo<dim>, MeshWorker::IntegrationInfoBox<dim> >
(dof_handler.begin_active(),
dof_handler.end(),
dof_info,
mg_matrix_dg_up.resize(0, n_levels-1);
mg_matrix_dg_down.resize(0, n_levels-1);
- for (unsigned int level=mg_sparsity.get_minlevel();
- level<=mg_sparsity.get_maxlevel();++level)
+ for (unsigned int level=mg_sparsity.min_level();
+ level<=mg_sparsity.max_level();++level)
{
CompressedSparsityPattern c_sparsity(mgdofs.n_dofs(level));
CompressedSparsityPattern ci_sparsity;