From: Matthias Maier Date: Fri, 28 Aug 2015 04:29:01 +0000 (-0500) Subject: Testsuite: another iteration... X-Git-Tag: v8.4.0-rc2~530^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=765a32e41cc7985ec8ecbec2698abb4262dbc8df;p=dealii.git Testsuite: another iteration... --- diff --git a/tests/deal.II/memory_consumption_01.cc b/tests/base/memory_consumption_01.cc similarity index 100% rename from tests/deal.II/memory_consumption_01.cc rename to tests/base/memory_consumption_01.cc diff --git a/tests/deal.II/memory_consumption_01.with_64bit_indices=off.output b/tests/base/memory_consumption_01.with_64bit_indices=off.output similarity index 100% rename from tests/deal.II/memory_consumption_01.with_64bit_indices=off.output rename to tests/base/memory_consumption_01.with_64bit_indices=off.output diff --git a/tests/deal.II/memory_consumption_01.with_64bit_indices=on.output b/tests/base/memory_consumption_01.with_64bit_indices=on.output similarity index 100% rename from tests/deal.II/memory_consumption_01.with_64bit_indices=on.output rename to tests/base/memory_consumption_01.with_64bit_indices=on.output diff --git a/tests/deal.II/helmholtz.h b/tests/deal.II/helmholtz.h deleted file mode 100644 index d35cf8b080..0000000000 --- a/tests/deal.II/helmholtz.h +++ /dev/null @@ -1,26 +0,0 @@ - -#include "../tests.h" -#include - -/** - * Generator for system matrix and right hand side. - */ -class Helmholtz -{ -public: - template - void build_all(MATRIX &A, - VECTOR &f, - const DoFHandler &dof, - const Quadrature &quadrature, - const Function &rhs); - - template - void build_mgmatrix(MGLevelObject &A, - const DoFHandler &dof, - const Quadrature &quadrature); -}; - -#include "helmholtz1.th" -#include "helmholtz1mg.th" - diff --git a/tests/deal.II/helmholtz1.th b/tests/deal.II/helmholtz1.th deleted file mode 100644 index 75dc5f8878..0000000000 --- a/tests/deal.II/helmholtz1.th +++ /dev/null @@ -1,69 +0,0 @@ - -template -void -Helmholtz::build_all(MATRIX& A, - VECTOR& f, - const DoFHandler& dof, - const Quadrature& quadrature, - const Function& rhs) -{ - const unsigned int fe_dofs = dof.get_fe().n_dofs_per_cell(); - FEValues fe(dof.get_fe(), quadrature, - UpdateFlags(update_values | update_gradients | - update_JxW_values | update_q_points)); - - Vector elvec(fe_dofs); - FullMatrix elmat(fe_dofs); - std::vector indices(fe_dofs); - -//////////////////////////////////////////////////// -// Loop for computing the element matrices -//////////////////////////////////////////////////// - - for (DoFHandler::active_cell_iterator c = dof.begin_active() - ; c != dof.end() ; ++c) - { - elmat.clear(); - elvec.clear(); - fe.reinit(c); - - // Quadrature loop - - for (unsigned k=0;k loc = fe.quadrature_point(k); - - // Test function loop - for (unsigned i=0;i dv = fe.shape_grad(i,k); - double v = fe.shape_value(i,k); - - elvec(i) += fe.JxW(k) * - rhs.value(loc) * v; - - //Trial function loop - for (unsigned j=0;j du = fe.shape_grad(j,k); - double u = fe.shape_value(j,k); - - elmat(i,j) += fe.JxW(k) * - (0.1*u*v + du*dv) - ; - } - } - } - - c->get_dof_indices(indices); - for (unsigned i=0;i -void -Helmholtz::build_mgmatrix(MGLevelObject& A, - const DoFHandler& dof, - const Quadrature& quadrature) -{ - const unsigned int fe_dofs = dof.get_fe().n_dofs_per_cell(); - FEValues fe(dof.get_fe(), quadrature, - UpdateFlags(update_values | update_gradients | - update_JxW_values | update_q_points)); - - Vector elvec(fe_dofs); - FullMatrix elmat(fe_dofs); - std::vector indices(fe_dofs); - -//////////////////////////////////////////////////// -// Loop for computing the element matrices -//////////////////////////////////////////////////// - - DoFHandler::cell_iterator dc = dof.DoFHandler::begin(); - for (DoFHandler::cell_iterator c = dof.begin() - ; c != dof.end() ; ++c, ++dc) - { - elmat.clear(); - elvec.clear(); - fe.reinit(dc); - - // Quadrature loop - - for (unsigned k=0;k loc = fe.quadrature_point(k); - - // Test function loop - for (unsigned i=0;i dv = fe.shape_grad(i,k); - double v = fe.shape_value(i,k); - - //Trial function loop - for (unsigned j=0;j du = fe.shape_grad(j,k); - double u = fe.shape_value(j,k); - - elmat(i,j) += fe.JxW(k) * - (0.1*u*v + du*dv) - ; - } - } - } - - const unsigned int level = c->level(); - - c->get_mg_dof_indices(indices); - for (unsigned i=0;i