From 092ca71ec7d892c527c8f5c9a28ce108234b5d20 Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Wed, 26 Mar 2025 21:39:06 -0400 Subject: [PATCH] Portable::MatrixFree BlockVector test update --- .../matrix_free_kokkos/cell_loop_block_01.cc | 11 +- .../matrix_free_kokkos/cell_loop_block_02.cc | 207 ++++++++++++++++++ .../cell_loop_block_02.output | 4 + 3 files changed, 215 insertions(+), 7 deletions(-) create mode 100644 tests/matrix_free_kokkos/cell_loop_block_02.cc create mode 100644 tests/matrix_free_kokkos/cell_loop_block_02.output diff --git a/tests/matrix_free_kokkos/cell_loop_block_01.cc b/tests/matrix_free_kokkos/cell_loop_block_01.cc index ba1e413723..b2fbc394d7 100644 --- a/tests/matrix_free_kokkos/cell_loop_block_01.cc +++ b/tests/matrix_free_kokkos/cell_loop_block_01.cc @@ -13,22 +13,19 @@ // ------------------------------------------------------------------------ -// check that Portable::FEEvaluation::submit_dof_value/get_dof_value -// works correctly. - -#include "deal.II/base/memory_space.h" +// check that Portable::MatrixFree::cell_loop works with BlockVector #include #include -#include "deal.II/lac/la_parallel_block_vector.h" +#include #include #include -#include "../tests.h" +#include -#include "Kokkos_Core.hpp" +#include "../tests.h" template +#include + +#include + +#include +#include + +#include + +#include "../tests.h" + +template +class MatrixFreeTest +{ +public: + static const unsigned int n_local_dofs = Utilities::pow(fe_degree + 1, dim); + static const unsigned int n_q_points = Utilities::pow(n_q_points_1d, dim); + + MatrixFreeTest(const Portable::MatrixFree &data_in) + : data(data_in){}; + + DEAL_II_HOST_DEVICE void + operator()(const typename Portable::MatrixFree::Data *data, + const Portable::DeviceVector &src, + Portable::DeviceVector &dst) const + { + Portable::FEEvaluation fe_eval( + data); + + fe_eval.read_dof_values(src); + fe_eval.distribute_local_to_global(dst); + } + + void + test() const + { + LinearAlgebra::distributed::Vector dst; + LinearAlgebra::distributed::Vector src; + + data.initialize_dof_vector(dst); + data.initialize_dof_vector(src); + src.add(1.0); + + data.cell_loop(*this, src, dst); + + Kokkos::fence(); + + deallog << "OK:" << dst.linfty_norm() << std::endl; + } + +protected: + const Portable::MatrixFree &data; +}; + + +template +class MatrixFreeTestBlock +{ +public: + static const unsigned int n_local_dofs = Utilities::pow(fe_degree + 1, dim); + static const unsigned int n_q_points = Utilities::pow(n_q_points_1d, dim); + + MatrixFreeTestBlock(const Portable::MatrixFree &data_in) + : data(data_in){}; + + DEAL_II_HOST_DEVICE void + operator()(const typename Portable::MatrixFree::Data *data, + const Portable::DeviceBlockVector &src, + Portable::DeviceBlockVector &dst) const + { + Portable::FEEvaluation fe_eval( + data); + + fe_eval.read_dof_values(src.block(0)); + fe_eval.distribute_local_to_global(dst.block(0)); + fe_eval.read_dof_values(src.block(1)); + fe_eval.distribute_local_to_global(dst.block(1)); + } + + void + test() const + { + LinearAlgebra::distributed::BlockVector dst( + 2); + LinearAlgebra::distributed::BlockVector src( + 2); + + data.initialize_dof_vector(dst.block(0)); + data.initialize_dof_vector(dst.block(1)); + data.initialize_dof_vector(src.block(0)); + data.initialize_dof_vector(src.block(1)); + src.block(0).add(1.0); + src.block(1).add(2.0); + + data.cell_loop(*this, src, dst); + + Kokkos::fence(); + + deallog << "OK:" << dst.block(0).linfty_norm() << " " + << dst.block(1).linfty_norm() << std::endl; + } + +protected: + const Portable::MatrixFree &data; +}; + +template +const unsigned int + MatrixFreeTest::n_local_dofs; + +template +const unsigned int + MatrixFreeTest::n_q_points; + +template +const unsigned int + MatrixFreeTestBlock::n_local_dofs; + +template +const unsigned int + MatrixFreeTestBlock::n_q_points; + + +template +void +do_test(const DoFHandler &dof, + const AffineConstraints &constraints) +{ + Portable::MatrixFree mf_data; + { + const QGauss<1> quad(fe_degree + 1); + typename Portable::MatrixFree::AdditionalData data; + data.mapping_update_flags = update_values | update_gradients | + update_JxW_values | update_quadrature_points; + mf_data.reinit(dof, constraints, quad, data); + } + + deallog << "Testing " << dof.get_fe().get_name() << std::endl; + MatrixFreeTest mf(mf_data); + mf.test(); + MatrixFreeTestBlock mfb(mf_data); + mfb.test(); +} + + +template +void +test() +{ + Triangulation tria; + GridGenerator::hyper_cube(tria); + + // refine first and last cell + tria.begin(tria.n_levels() - 1)->set_refine_flag(); + tria.last()->set_refine_flag(); + tria.execute_coarsening_and_refinement(); + + FE_Q fe(fe_degree); + DoFHandler dof(tria); + dof.distribute_dofs(fe); + + AffineConstraints constraints; + DoFTools::make_hanging_node_constraints(dof, constraints); + constraints.close(); + + do_test(dof, constraints); +} + + + +int +main() +{ + initlog(); + + Kokkos::initialize(); + + test<2, 1>(); + + Kokkos::finalize(); + + return 0; +} diff --git a/tests/matrix_free_kokkos/cell_loop_block_02.output b/tests/matrix_free_kokkos/cell_loop_block_02.output new file mode 100644 index 0000000000..e771e3aa60 --- /dev/null +++ b/tests/matrix_free_kokkos/cell_loop_block_02.output @@ -0,0 +1,4 @@ + +DEAL::Testing FE_Q<2>(1) +DEAL::OK:4.00000 +DEAL::OK:4.00000 8.00000 -- 2.39.5